This is an R Markdown Notebook. When you execute code within the notebook, the results appear beneath the code.
Try executing this chunk by clicking the Run button within the chunk or by placing your cursor inside it and pressing Ctrl+Shift+Enter.
rm(list=ls())
getwd()
library(rio)
library(tidyverse)
a <- import("Climbee_Linz_all_20220220.xlsx", stringsAsFactors = T) # convenience function from package "rio"
str(a)
temp <- a %>%
group_by(F_Artbezeichnung, Weibchen, Männchen, Ort, Ortgruppe, aktiv_fraglich, Tag, Monat, Jahr) %>%
filter(n()>1) %>%
summarize(duplicates=n()) %>%
pivot_longer(cols = c(Weibchen,Männchen), names_to = "Geschlecht", values_to = "Anzahl",
values_drop_na = F) %>%
arrange(desc(Anzahl))
a0 <- a %>%
#unite("Fundortbeschreibung", c(Ort, Ort_Anmerkung, Notiz), remove = F, sep = "#") %>%
#filter(!Bundesland == "Kärnten") %>%
rename(Taxon = F_Artbezeichnung,
Fundort = Ortgruppe,
#Fundortcode = Ortnummer,
Fundortbeschreibung = Ort) %>%
mutate(Unbekannt = NA) %>%
mutate(Unbekannt = replace(Unbekannt, is.na(Weibchen) & is.na(Männchen), 1)) %>%
pivot_longer(cols = c(Weibchen,Männchen,Unbekannt), names_to = "Geschlecht", values_to = "Anzahl",
values_drop_na = TRUE) %>%
dplyr::select(Taxon, Geschlecht, Anzahl, Fundort, Fundortbeschreibung, Tag, Monat, Jahr) %>%
mutate(Fundortbeschreibung = factor(Fundortbeschreibung),
Fundort = factor(Fundort),
Geschlecht = factor(Geschlecht),
Taxon = factor(Taxon))
str(a0)
summary(a0$Jahr)
a1 <- a0 %>%
#filter(!Taxon == "Andrena ovatula - Gruppe") %>%
filter(Jahr >= 1910) %>% #exclude data before 1910
#distinct() #exclude all possible double entries
mutate(Taxon = replace(Taxon, Taxon == "Bombus lucorum (Linnaeus 1761)", "Bombus terrestris-lucorum")) %>%
mutate(Taxon = replace(Taxon, Taxon == "Bombus terrestris (Linnaeus 1758)", "Bombus terrestris-lucorum")) %>%
mutate(Taxon = replace(Taxon, Taxon == "Bombus terrestris (Linnaeus 1758)", "Bombus terrestris-lucorum")) %>%
mutate(Taxon = replace(Taxon, Taxon == "Osmia fulviventris Panzer 1798", "Osmia niveata (Fabricius 1804)")) %>%
mutate(Taxon = replace(Taxon, Taxon == "Hylaeus dilatatus (Kirby 1802)", "Hylaeus annularis (Kirby 1802)")) %>%
mutate(Taxon = replace(Taxon, Taxon == "Lasioglossum limbellum ventrale Per.", "Lasioglossum limbellum (Morawitz 1876)")) %>%
mutate(Taxon = replace(Taxon, Taxon == "Sphecodes miniatus-Gruppe", "Sphecodes miniatus (von Hagens)")) %>%
mutate(Taxon = replace(Taxon, Taxon == "Andrena ovatula - Gruppe", "Andrena ovatula (Kirby 1802)")) %>%
mutate(Taxon = replace(Taxon, Taxon == "Halictus confusus perkinsi Blüthgen", "Halictus confusus Smith 1853")) #%>%
#distinct()
a2 <- a1 %>%
#filter(Monat %in% c(4,5,6,7,8)) %>%
filter(Tag <= 31) %>%
mutate(Tag = as.character(Tag)) %>%
mutate(Tag = replace(Tag, Tag == "1", "01")) %>%
mutate(Tag = replace(Tag, Tag == "2", "02")) %>%
mutate(Tag = replace(Tag, Tag == "3", "03")) %>%
mutate(Tag = replace(Tag, Tag == "4", "04")) %>%
mutate(Tag = replace(Tag, Tag == "5", "05")) %>%
mutate(Tag = replace(Tag, Tag == "6", "06")) %>%
mutate(Tag = replace(Tag, Tag == "7", "07")) %>%
mutate(Tag = replace(Tag, Tag == "8", "08")) %>%
mutate(Tag = replace(Tag, Tag == "9", "09")) %>%
mutate(Monat = as.character(Monat)) %>%
mutate(Monat = replace(Monat, Monat == "1", "01")) %>%
mutate(Monat = replace(Monat, Monat == "2", "02")) %>%
mutate(Monat = replace(Monat, Monat == "3", "03")) %>%
mutate(Monat = replace(Monat, Monat == "4", "04")) %>%
mutate(Monat = replace(Monat, Monat == "5", "05")) %>%
mutate(Monat = replace(Monat, Monat == "6", "06")) %>%
mutate(Monat = replace(Monat, Monat == "7", "07")) %>%
mutate(Monat = replace(Monat, Monat == "8", "08")) %>%
mutate(Monat = replace(Monat, Monat == "9", "09")) %>%
unite("Jahr_Monat_Tag", c(Jahr, Monat, Tag), remove = F, sep = "") %>%
mutate(Jahr_Monat_Tag = as.character(Jahr_Monat_Tag)) %>%
mutate(date = as_date(Jahr_Monat_Tag)) %>%
mutate(week = week(date))
a3 <- a2 %>%
#filter(week >= 16 | Fundort == "Wegscheid") %>%
drop_na(Taxon) %>%
separate(Taxon, c("x1", "x2", "x3", "x4"), sep = " ", remove = F) %>%
unite("Gattung_Art", c(x1, x2), remove = F, sep = " ") %>%
rename(Gattung = x1) %>%
dplyr::select(-c(x2:x4)) %>%
mutate(Gattung_Art = replace(Gattung_Art, Gattung_Art == "Anthidium strigatum", "Anthidiellum strigatum")) %>%
mutate(Gattung_Art = replace(Gattung_Art, Gattung_Art == "Bombus lucorum" | Gattung_Art == "Bombus terrestris", "Bombus terrestris-lucorum")) %>%
mutate(Gattung_Art = replace(Gattung_Art, Gattung_Art == "Osmia adunca", "Hoplitis adunca")) %>%
mutate(Gattung_Art = replace(Gattung_Art, Gattung_Art == "Osmia mitis", "Hoplitis mitis"))
# Identify community sampling events
community_events <- a3 %>%
filter(!is.na(date)) %>%
group_by(date) %>%
summarize(n_species = n_distinct(Gattung_Art)) %>%
filter(n_species > 1) %>%
mutate(logL = log1p(n_species))
# Preprocess the data
a4 <- a3 %>%
filter(!is.na(date)) %>%
ungroup %>%
inner_join(community_events, by = "date") %>%
mutate(Monat = as.numeric(Monat)) %>%
filter(Monat > 3 & Monat < 9) %>%
rename(Plot = Fundort,
Date = date,
#Year = Jahr,
Species = Gattung_Art,
Month = Monat) %>%
mutate(Species = as.factor(Species)) %>%
mutate(Year = year(Date),
Decade = floor(Year / 10) * 10) %>%
dplyr::select(Species, Plot, Decade, Year)
# All possible combinations of Species, Site, and Year
all_combinations <- expand.grid(
Species = unique(a4$Species),
Site = unique(a4$Plot),
Decade = unique(a4$Decade)
)
# Joining data with all_combinations to include non-detections
a5 <- full_join(
all_combinations,
a4,
by = c("Species" = "Species", "Site" = "Plot", "Decade" = "Decade")
)
# Adding 'logL' column and setting 'logL' to 0 where no species were detected
a5 <- left_join(
a5,
visit_list_lengths,
by = c("Site" = "Plot", "Decade" = "Decade")
) #%>%
#drop_na(logL)
# Creating a detection status column ('y')
a5 <- a5 %>%
mutate(y = if_else(is.na(Year), 0, 1)) %>%
drop_na(logL) %>%
#mutate(y = if_else(is.na(logL), NA, y)) %>%
dplyr::select(-Year, -n_species) %>%
arrange(Decade) %>%
rename(Year = Decade) %>%
distinct()
# Creating a list of data frames, one for each species
species_list <- split(a5, a5$Species)
library(rjags)
#Write the model with Bernoulli correction
model_string <- "
model{
### Priors ###
# State model priors
b[1] ~ dnorm(mu.b, 0.0001) # random walk prior on year effect
for(t in 2:nyear){
b[t] ~ dnorm(b[t-1], tau.b)
}
mu.b ~ dnorm(0, 0.01)
tau.b <- 1/(sd.b * sd.b)
sd.b ~ dt(0, 1, 1)T(0,) # half-Cauchy hyperpriors (replace half-uniform above)
for (i in 1:nsite) {
u[i] ~ dnorm(0, tau.u) # random site effect
}
tau.u <- 1/(sd.u * sd.u)
sd.u ~ dt(0, 1, 1)T(0,) # half-Cauchy hyperpriors (replace half-uniform above)
# Observation model priors
for (t in 1:nyear) {
a[t] ~ dnorm(mu.a, tau.a) # random year effect
}
mu.a ~ dnorm(0, 0.01)
tau.a <- 1 / (sd.a * sd.a)
sd.a ~ dt(0, 1, 1)T(0,) # half-Cauchy hyperpriors (replace half-uniform above)
c ~ dunif(-10, 10) # sampling effort effect
### Model ###
# State model
for (i in 1:nsite){
for (t in 1:nyear){
z[i,t] ~ dbern(psi[i,t])
logit(psi[i,t])<- b[t] + u[i]
}}
# Observation model
for(j in 1:nvisit) {
y[j] ~ dbern(Py[j]+0.00001)
Py[j]<- z[Site[j],Year[j]] * p[j]
logit(p[j]) <- a[Year[j]] + c*logL[j]
}
### Derived parameters ###
# Finite sample occupancy - proportion of occupied sites
for (t in 1:nyear) {
psi.fs[t] <- sum(z[1:nsite,t])/nsite
}
#data#
#monitor#
}
"
#, "Bombus pomorum", "Andrena agilissima", "Anthidium manicatum", "Halictus scabiosae", "Osmia pilicornis", "Hylaeus styriacus", "Eucera nigrescens", "Andrena lagopus"
# List of species
species_names <- c("Bombus pomorum", "Lasioglossum marginatum", "Andrena agilissima", "Anthidium manicatum", "Halictus scabiosae", "Osmia pilicornis", "Hylaeus styriacus", "Eucera nigrescens", "Andrena lagopus")
#spec <- c("Hylaeus styriacus")
# Data frame to hold the results
occ_results <- data.frame()
#spec <- "Andrena agilissima"
# Loop through each species
for (spec in species_names) {
#select species
species_data <- species_list[[spec]] %>%
arrange(Site, Year) %>%
#drop_na(y) %>%
mutate(y = as.numeric(y),
logL = as.numeric(logL),
year_rank = as.integer(as.factor(Year)),
site_ID = as.numeric(factor(Site, levels = unique(Site)))) %>%
arrange(Year, Site) %>%
mutate(visit = 1:n())
specname <- species_data$Species
# create vectors for data.list
nyear <-length(unique(species_data$year_rank)) ### number of years
nsite <-max(species_data$site_ID) ### number of sites
nvisit <-max(species_data$visit) ### number of visits
y <-species_data$y ### detection status of visit
logL <-species_data$logL ### logarithm of list length
Site <-species_data$site ### Site associated with visit
Year <-species_data$year_rank ### Year associated with visit
# combine data into list
data.list<-list("nyear"=nyear,"nsite"=nsite,
"nvisit"=nvisit,
"y"=y ,"logL"=logL,
"Site"=Site ,"Year"=Year)
# Function to generate initial values
generate_inits <- function() {
list(
"a" = runif(nyear, -2,2),
"b"=runif(nyear,-2,2),
"u"=runif(nsite,-2,2),
c=runif(1,-2,2)
)
}
# Generate initial values for each chain
init.list <- lapply(1:2, function(x) generate_inits())
# general parameter settings
n.iter <- 6000
n.chains <- 2
n.thin <- 3
n.adapt <- 1500
n.burnin <- 1500
plot <- T
#savepath <- paste0(getwd(),"/OUTPUT/")
savedata <- T
save.pars <- c(paste0("psi.fs"))
# run randomwalk model
jagsres <- autorun.jags(model= model_string, method="parallel", max.time="96 hours",
data=data.list, modules=c("glm","dic"), monitor=save.pars, inits=init.list,
thin=n.thin, thin.sample=T, adapt=n.adapt, startburnin=n.burnin,
n.chains=n.chains, startsample=n.iter)
#Geweke plot
parlabeldf<-data.frame(Parameter= paste0("psi.fs[",1:12,"]"),
Label=paste0(seq(1910,2020,10),"s"))
jagsres.ggs<-ggs(jagsres$mcmc,keep_original_order=T, family="psi.fs", par_labels=parlabeldf)
print(ggs_geweke(jagsres.ggs)+ggtitle(paste("Geweke Plot for", specname)))
#Autocorrelation Plot
print(ggs_autocorrelation(jagsres.ggs))
#Occupancy estimates plot
jagsres.ci<-ci(jagsres.ggs)
jagsres.ci$parnum<-as.numeric(as.character(gsub("s","",jagsres.ci$Parameter)))
occ.lm<-lm(jagsres.ci$median~jagsres.ci$parnum)
res.norm<-shapiro.test(occ.lm$residuals)
occ.int<-occ.lm$coefficients[["(Intercept)"]]
occ.slo<-occ.lm$coefficients[["jagsres.ci$parnum"]]
# Get the summary of the linear model
summary_occ.lm <- summary(occ.lm)
# Extract the slope (coefficient), p-value, and R-squared
slope <- summary_occ.lm$coefficients["jagsres.ci$parnum", "Estimate"]
p_val <- summary_occ.lm$coefficients["jagsres.ci$parnum", "Pr(>|t|)"]
r_squared <- summary_occ.lm$r.squared
occ.res <- ggplot(jagsres.ci, aes(x = parnum, y = median)) +
# Use theme_bw for a clean, professional look
theme_bw() +
# Add the points with a simple, professional shape
geom_point(size = 2.5, shape = 15, color = "black") +
# Add the regression line, with a thicker line size for visibility
geom_abline(slope = occ.slo, intercept = occ.int, col = "red", size = 1) +
# Add the dashed line, with a slightly thicker line size
geom_line(linetype = "dashed", size = 1.2) +
# Add the confidence interval, with a more visible alpha
geom_ribbon(aes(ymin = Low, ymax = High), color = "grey20", alpha = 0.2) +
# Modify scales
scale_y_continuous(limits = c(0, 1), expand = c(0, 0), breaks = seq(0, 1, 0.1),
labels = scales::percent) +
scale_x_continuous(limits = c(min(jagsres.ci$parnum), max(jagsres.ci$parnum)),
expand = c(0, 0.5), breaks = jagsres.ci$parnum,
labels = jagsres.ci$Parameter) +
# Modify theme elements
theme(
plot.title = element_text(hjust = 0.5), # Center the plot title
axis.text.x = element_text(hjust = 0.85), # Adjust x axis labels
axis.title.x = element_text(face = "bold"), # Make x axis title bold
axis.title.y = element_text(face = "bold"), # Make y axis title bold
panel.grid.major = element_line(color = "grey60", linetype = "dotted") # Adjust grid
) +
# Update titles
labs(
title = sprintf("Occupancy and CIs for %s", specname, occ.slo),
x = "Timestep",
y = "Median Occupancy (%)"
) +
#annotate text slope, p-vlaue, R²
annotate("text", x = median(jagsres.ci$parnum), y = 0.9, # adjust these to place the text in your plot
label = sprintf("Slope: %.2f, P-value: %.6f, R²: %.2f", slope, p_val, r_squared),
hjust = 0, vjust = 0, size = 4, colour = "black") # adjust size and colour as needed
print(occ.res)
# Compute the raw occurrence proportion for each species per decade
species_data_sub <- species_data %>%
filter(Species == spec) %>%
group_by(Species, Year) %>%
summarise(total_sites = n(),
occupied_sites = sum(y),
occurrence = mean(y),
.groups = "drop")
# Generate the ggplot for each species
p <- ggplot(species_data_sub, aes(x = Year, y = occurrence)) +
geom_line(size = 1.2, color = "black") +
scale_y_continuous(limits = c(0, 1), expand = c(0, 0), breaks = seq(0, 1, 0.1), labels = scales::percent) +
scale_x_continuous(breaks = seq(min(species_data_sub$Year), max(species_data_sub$Year), 10)) +
labs(x = "Decade", y = "Occupancy Proportion (%)", title = sprintf("Raw Occupancy Proportion for %s per Decade", spec)) +
theme_bw()
# Print the plot
print(p)
# After running the model and generating the plot, add the data to the data frame
occ_results <- rbind(occ_results, data.frame(Species = spec,
Slope = slope,
PValue = p_val,
RSquared = r_squared,
CI_low = min(jagsres.ci$Low),
CI_high = max(jagsres.ci$High)))
}
Warnung: You attempted to start parallel chains without setting different PRNG for each chain, which is not recommended. Different .RNG.name values have been added to each set of initial values.
Auto-run JAGS
Running a pilot chain...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish
before continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:48:28 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. Updating 1500
-------------------------------------------------| 1500
************************************************** 100%
. . Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was above 1.05 for 10 parameters after 9000 iterations
taking 10.9 seconds (multi-variate psrf = 1.335). This may indicate poor convergence.
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish
before continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:48:40 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 3 parameters after 28500
iterations taking 21.3 seconds (multi-variate psrf = 1.054).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish
before continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:48:50 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 8 parameters after 48000
iterations taking 28.8 seconds (multi-variate psrf = 1.055).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish
before continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:48:58 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 9 parameters after 67500
iterations taking 36.3 seconds (multi-variate psrf = 1.464).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish
before continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:49:06 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 9 parameters after 87000
iterations taking 43.8 seconds (multi-variate psrf = 1.993).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish
before continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:49:14 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 8 parameters after 106500
iterations taking 51.2 seconds (multi-variate psrf = 1.081).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for
all chains to finish before continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:49:21 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 126000 iterations
taking 1 minutes (multi-variate psrf = 1.925).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:49:32 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 145500 iterations
taking 1.2 minutes (multi-variate psrf = 33.056).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:49:42 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 165000 iterations
taking 1.4 minutes (multi-variate psrf = 24.468).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:49:52 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 184500 iterations
taking 1.5 minutes (multi-variate psrf = 25.159).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:50:02 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 204000 iterations
taking 1.7 minutes (multi-variate psrf = 13.965).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:50:13 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 223500 iterations
taking 1.9 minutes (multi-variate psrf = 1.416).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:50:23 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 3 parameters after 243000 iterations
taking 2 minutes (multi-variate psrf = 1.066).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:50:31 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 3 parameters after 262500 iterations
taking 2.1 minutes (multi-variate psrf = 1.074).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:50:42 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 4 parameters after 282000 iterations
taking 2.3 minutes (multi-variate psrf = 1.018).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:50:50 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 2 parameters after 301500 iterations
taking 2.4 minutes (multi-variate psrf = 1.028).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:50:57 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 2 parameters after 321000 iterations
taking 2.5 minutes (multi-variate psrf = 1.02).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:51:05 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 2 parameters after 340500 iterations
taking 2.6 minutes (multi-variate psrf = 1.019).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:51:12 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 1 parameter after 360000 iterations taking
2.8 minutes (multi-variate psrf = 1.007).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:51:20 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 7 parameters after 379500 iterations
taking 2.9 minutes (multi-variate psrf = 1.055).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:51:27 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 399000 iterations
taking 3 minutes (multi-variate psrf = 1.158).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:51:38 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 418500 iterations
taking 3.2 minutes (multi-variate psrf = 1.236).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:51:48 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 8 parameters after 438000 iterations
taking 3.3 minutes (multi-variate psrf = 1.049).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:51:56 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 8 parameters after 457500 iterations
taking 3.5 minutes (multi-variate psrf = 1.068).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:52:03 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 4 parameters after 477000 iterations
taking 3.6 minutes (multi-variate psrf = 1.065).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:52:14 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 6 parameters after 496500 iterations
taking 3.7 minutes (multi-variate psrf = 1.028).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:52:21 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 3 parameters after 516000 iterations
taking 3.9 minutes (multi-variate psrf = 1.05).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:52:29 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 11 parameters after 535500 iterations
taking 4 minutes (multi-variate psrf = 1.404).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:52:40 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 1 parameter after 555000 iterations taking
4.2 minutes (multi-variate psrf = 1.033).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:52:47 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 9 parameters after 574500 iterations
taking 4.3 minutes (multi-variate psrf = 1.354).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:52:55 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 3 parameters after 594000 iterations
taking 4.4 minutes (multi-variate psrf = 1.047).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:53:03 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 1 parameter after 613500 iterations taking
4.6 minutes (multi-variate psrf = 1.027).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:53:13 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 2 parameters after 633000 iterations
taking 4.7 minutes (multi-variate psrf = 1.026).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:53:21 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 8 parameters after 652500 iterations
taking 4.9 minutes (multi-variate psrf = 1.057).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:53:31 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 11 parameters after 672000 iterations
taking 5 minutes (multi-variate psrf = 1.085).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:53:42 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 8 parameters after 691500 iterations
taking 5.2 minutes (multi-variate psrf = 1.063).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:53:52 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 5 parameters after 711000 iterations
taking 5.3 minutes (multi-variate psrf = 1.047).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:54:00 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 9 parameters after 730500 iterations
taking 5.5 minutes (multi-variate psrf = 1.227).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:54:10 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 7 parameters after 750000 iterations
taking 5.6 minutes (multi-variate psrf = 1.079).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:54:18 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 7 parameters after 769500 iterations
taking 5.8 minutes (multi-variate psrf = 1.055).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:54:28 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 8 parameters after 789000 iterations
taking 5.9 minutes (multi-variate psrf = 1.155).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:54:36 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 8 parameters after 808500 iterations
taking 6 minutes (multi-variate psrf = 1.067).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:54:44 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 8 parameters after 828000 iterations
taking 6.2 minutes (multi-variate psrf = 1.092).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:54:51 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 1 parameter after 847500 iterations taking
6.3 minutes (multi-variate psrf = 1.018).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:54:59 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 7 parameters after 867000 iterations
taking 6.4 minutes (multi-variate psrf = 1.09).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:55:06 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 5 parameters after 886500 iterations
taking 6.5 minutes (multi-variate psrf = 1.047).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:55:14 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 2 parameters after 906000 iterations
taking 6.6 minutes (multi-variate psrf = 1.013).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:55:22 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 8 parameters after 925500 iterations
taking 6.8 minutes (multi-variate psrf = 1.064).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:55:29 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 10 parameters after 945000 iterations
taking 6.9 minutes (multi-variate psrf = 1.087).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:55:37 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 7 parameters after 964500 iterations
taking 7.1 minutes (multi-variate psrf = 1.085).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:55:47 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 9 parameters after 984000 iterations
taking 7.2 minutes (multi-variate psrf = 1.076).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:55:58 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 11 parameters after 1003500 iterations
taking 7.3 minutes (multi-variate psrf = 1.205).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:56:05 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 1023000 iterations
taking 7.5 minutes (multi-variate psrf = 10.296).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:56:16 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 1042500 iterations
taking 7.7 minutes (multi-variate psrf = 1.91).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:56:26 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 1062000 iterations
taking 7.9 minutes (multi-variate psrf = 25.275).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:56:36 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 9 parameters after 1081500 iterations
taking 8 minutes (multi-variate psrf = 1.233).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:56:44 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 8 parameters after 1101000 iterations
taking 8.1 minutes (multi-variate psrf = 1.102).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:56:51 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 3 parameters after 1120500 iterations
taking 8.2 minutes (multi-variate psrf = 1.032).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:56:59 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 8 parameters after 1140000 iterations
taking 8.3 minutes (multi-variate psrf = 1.09).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:57:07 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 6 parameters after 1159500 iterations
taking 8.5 minutes (multi-variate psrf = 1.064).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:57:17 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 2 parameters after 1179000 iterations
taking 8.6 minutes (multi-variate psrf = 1.019).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:57:25 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 1 parameter after 1198500 iterations
taking 8.8 minutes (multi-variate psrf = 1.022).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:57:32 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 2 parameters after 1218000 iterations
taking 8.9 minutes (multi-variate psrf = 1.018).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:57:40 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 6 parameters after 1237500 iterations
taking 9 minutes (multi-variate psrf = 1.03).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:57:48 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 11 parameters after 1257000 iterations
taking 9.2 minutes (multi-variate psrf = 1.398).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:57:58 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 10 parameters after 1276500 iterations
taking 9.3 minutes (multi-variate psrf = 1.135).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:58:09 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 11 parameters after 1296000 iterations
taking 9.5 minutes (multi-variate psrf = 1.617).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:58:19 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 9 parameters after 1315500 iterations
taking 9.7 minutes (multi-variate psrf = 1.578).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:58:30 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 11 parameters after 1335000 iterations
taking 9.8 minutes (multi-variate psrf = 1.441).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:58:40 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 4 parameters after 1354500 iterations
taking 10 minutes (multi-variate psrf = 1.027).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:58:48 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 10 parameters after 1374000 iterations
taking 10.1 minutes (multi-variate psrf = 1.216).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:58:58 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 1 parameter after 1393500 iterations
taking 10.3 minutes (multi-variate psrf = 1.021).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:59:06 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 8 parameters after 1413000 iterations
taking 10.4 minutes (multi-variate psrf = 1.137).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:59:17 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 4 parameters after 1432500 iterations
taking 10.5 minutes (multi-variate psrf = 1.046).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:59:24 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 2 parameters after 1452000 iterations
taking 10.7 minutes (multi-variate psrf = 1.022).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:59:32 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 3 parameters after 1471500 iterations
taking 10.8 minutes (multi-variate psrf = 1.048).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:59:39 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 9 parameters after 1491000 iterations
taking 11 minutes (multi-variate psrf = 1.494).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 18:59:50 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 1510500 iterations
taking 11.1 minutes (multi-variate psrf = 15.298).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:00:01 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 1530000 iterations
taking 11.3 minutes (multi-variate psrf = 22.722).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:00:11 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 1549500 iterations
taking 11.5 minutes (multi-variate psrf = 20.798).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:00:22 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 1569000 iterations
taking 11.6 minutes (multi-variate psrf = 4.606).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:00:32 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 1588500 iterations
taking 11.8 minutes (multi-variate psrf = 1.62).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:00:40 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 6 parameters after 1608000 iterations
taking 12 minutes (multi-variate psrf = 1.129).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:00:51 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 1627500 iterations
taking 12.1 minutes (multi-variate psrf = 1.155).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:01:02 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 6 parameters after 1647000 iterations
taking 12.3 minutes (multi-variate psrf = 1.138).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:01:12 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 1666500 iterations
taking 12.5 minutes (multi-variate psrf = 1.865).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:01:22 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 9 parameters after 1686000 iterations
taking 12.6 minutes (multi-variate psrf = 1.203).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:01:33 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 1705500 iterations
taking 12.8 minutes (multi-variate psrf = 9.083).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:01:44 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 1725000 iterations
taking 13 minutes (multi-variate psrf = 2.031).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:01:54 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 8 parameters after 1744500 iterations
taking 13.1 minutes (multi-variate psrf = 1.076).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:02:02 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 5 parameters after 1764000 iterations
taking 13.2 minutes (multi-variate psrf = 1.09).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:02:09 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 6 parameters after 1783500 iterations
taking 13.3 minutes (multi-variate psrf = 1.041).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:02:17 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 7 parameters after 1803000 iterations
taking 13.5 minutes (multi-variate psrf = 1.059).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:02:27 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 9 parameters after 1822500 iterations
taking 13.7 minutes (multi-variate psrf = 1.488).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:02:37 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 1842000 iterations
taking 13.9 minutes (multi-variate psrf = 3.054).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:02:48 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 1861500 iterations
taking 14 minutes (multi-variate psrf = 50.957).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:02:59 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 10 parameters after 1881000 iterations
taking 14.1 minutes (multi-variate psrf = 1.242).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:03:06 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 9 parameters after 1900500 iterations
taking 14.3 minutes (multi-variate psrf = 1.101).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:03:14 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 1920000 iterations
taking 14.4 minutes (multi-variate psrf = 27.616).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:03:25 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 2 parameters after 1939500 iterations
taking 14.6 minutes (multi-variate psrf = 1.059).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:03:36 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 7 parameters after 1959000 iterations
taking 14.7 minutes (multi-variate psrf = 1.111).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:03:43 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 8 parameters after 1978500 iterations
taking 14.9 minutes (multi-variate psrf = 1.105).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:03:51 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 11 parameters after 1998000 iterations
taking 15 minutes (multi-variate psrf = 1.336).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:04:02 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 8 parameters after 2017500 iterations
taking 15.2 minutes (multi-variate psrf = 1.09).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:04:10 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 3 parameters after 2037000 iterations
taking 15.3 minutes (multi-variate psrf = 1.035).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:04:17 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 5 parameters after 2056500 iterations
taking 15.4 minutes (multi-variate psrf = 1.041).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:04:25 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 10 parameters after 2076000 iterations
taking 15.5 minutes (multi-variate psrf = 1.123).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:04:32 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 8 parameters after 2095500 iterations
taking 15.7 minutes (multi-variate psrf = 1.106).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:04:44 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 7 parameters after 2115000 iterations
taking 15.8 minutes (multi-variate psrf = 1.06).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:04:51 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 10 parameters after 2134500 iterations
taking 16 minutes (multi-variate psrf = 1.223).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:05:02 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 8 parameters after 2154000 iterations
taking 16.2 minutes (multi-variate psrf = 1.104).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:05:12 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 4 parameters after 2173500 iterations
taking 16.3 minutes (multi-variate psrf = 1.031).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:05:19 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 3 parameters after 2193000 iterations
taking 16.4 minutes (multi-variate psrf = 1.012).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:05:27 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 4 parameters after 2212500 iterations
taking 16.5 minutes (multi-variate psrf = 1.038).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:05:35 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 10 parameters after 2232000 iterations
taking 16.7 minutes (multi-variate psrf = 1.231).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:05:45 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 3 parameters after 2251500 iterations
taking 16.8 minutes (multi-variate psrf = 1.038).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:05:53 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 1 parameter after 2271000 iterations
taking 16.9 minutes (multi-variate psrf = 1.022).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:06:00 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 3 parameters after 2290500 iterations
taking 17.1 minutes (multi-variate psrf = 1.028).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:06:08 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 8 parameters after 2310000 iterations
taking 17.2 minutes (multi-variate psrf = 1.246).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:06:19 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 9 parameters after 2329500 iterations
taking 17.4 minutes (multi-variate psrf = 1.072).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:06:30 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 8 parameters after 2349000 iterations
taking 17.5 minutes (multi-variate psrf = 1.096).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:06:38 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 6 parameters after 2368500 iterations
taking 17.7 minutes (multi-variate psrf = 1.07).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:06:48 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 5 parameters after 2388000 iterations
taking 17.8 minutes (multi-variate psrf = 1.034).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:06:56 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 3 parameters after 2407500 iterations
taking 18 minutes (multi-variate psrf = 1.017).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:07:04 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 7 parameters after 2427000 iterations
taking 18.1 minutes (multi-variate psrf = 1.051).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:07:11 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 9 parameters after 2446500 iterations
taking 18.2 minutes (multi-variate psrf = 1.445).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:07:19 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 2466000 iterations
taking 18.4 minutes (multi-variate psrf = 29.945).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:07:30 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 2485500 iterations
taking 18.5 minutes (multi-variate psrf = 5.035).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:07:40 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 8 parameters after 2505000 iterations
taking 18.7 minutes (multi-variate psrf = 1.085).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:07:48 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 8 parameters after 2524500 iterations
taking 18.8 minutes (multi-variate psrf = 1.124).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:07:56 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 2544000 iterations
taking 18.9 minutes (multi-variate psrf = 1.451).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:08:03 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 2563500 iterations
taking 19.1 minutes (multi-variate psrf = 12.614).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:08:13 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 2583000 iterations
taking 19.3 minutes (multi-variate psrf = 15.216).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:08:24 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 2602500 iterations
taking 19.4 minutes (multi-variate psrf = 9.764).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:08:36 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 2622000 iterations
taking 19.6 minutes (multi-variate psrf = 76.768).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:08:47 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 2641500 iterations
taking 19.8 minutes (multi-variate psrf = 70.171).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:08:57 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 2661000 iterations
taking 19.9 minutes (multi-variate psrf = 14.353).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:09:07 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 2680500 iterations
taking 20.1 minutes (multi-variate psrf = 51.45).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:09:18 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
Note: Unable to calculate the multivariate psrf
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 2700000 iterations
taking 20.2 minutes (Unable to calculate the multi-variate psrf).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:09:26 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 2719500 iterations
taking 20.4 minutes (multi-variate psrf = 19.906).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:09:36 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 2739000 iterations
taking 20.6 minutes (multi-variate psrf = 60.324).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:09:47 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 2758500 iterations
taking 20.7 minutes (multi-variate psrf = 70.508).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:09:57 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 2778000 iterations
taking 20.9 minutes (multi-variate psrf = 1.191).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:10:08 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 2797500 iterations
taking 21 minutes (multi-variate psrf = 1.212).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:10:15 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 8 parameters after 2817000 iterations
taking 21.2 minutes (multi-variate psrf = 1.195).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:10:27 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 3 parameters after 2836500 iterations
taking 21.4 minutes (multi-variate psrf = 1.073).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:10:37 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 8 parameters after 2856000 iterations
taking 21.5 minutes (multi-variate psrf = 1.062).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:10:45 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 2 parameters after 2875500 iterations
taking 21.6 minutes (multi-variate psrf = 1.023).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:10:53 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 7 parameters after 2895000 iterations
taking 21.8 minutes (multi-variate psrf = 1.243).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:11:04 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 9 parameters after 2914500 iterations
taking 22 minutes (multi-variate psrf = 1.57).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:11:15 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 10 parameters after 2934000 iterations
taking 22.2 minutes (multi-variate psrf = 1.638).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:11:25 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 2953500 iterations
taking 22.3 minutes (multi-variate psrf = 1.325).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:11:35 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 10 parameters after 2973000 iterations
taking 22.5 minutes (multi-variate psrf = 1.142).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:11:47 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 4 parameters after 2992500 iterations
taking 22.6 minutes (multi-variate psrf = 1.025).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:11:54 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 3012000 iterations
taking 22.8 minutes (multi-variate psrf = 1.503).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:12:05 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 7 parameters after 3031500 iterations
taking 22.9 minutes (multi-variate psrf = 1.027).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:12:13 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 2 parameters after 3051000 iterations
taking 23 minutes (multi-variate psrf = 1.016).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:12:21 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 5 parameters after 3070500 iterations
taking 23.2 minutes (multi-variate psrf = 1.041).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:12:28 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 1 parameter after 3090000 iterations
taking 23.3 minutes (multi-variate psrf = 1.023).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:12:37 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 9 parameters after 3109500 iterations
taking 23.4 minutes (multi-variate psrf = 1.157).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:12:45 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 7 parameters after 3129000 iterations
taking 23.6 minutes (multi-variate psrf = 1.038).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:12:53 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 3 parameters after 3148500 iterations
taking 23.7 minutes (multi-variate psrf = 1.049).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:13:04 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 4 parameters after 3168000 iterations
taking 23.9 minutes (multi-variate psrf = 1.073).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:13:15 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 11 parameters after 3187500 iterations
taking 24.1 minutes (multi-variate psrf = 1.198).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:13:25 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 11 parameters after 3207000 iterations
taking 24.3 minutes (multi-variate psrf = 1.205).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:13:36 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 10 parameters after 3226500 iterations
taking 24.4 minutes (multi-variate psrf = 1.248).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:13:47 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 4 parameters after 3246000 iterations
taking 24.6 minutes (multi-variate psrf = 1.05).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:13:55 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 2 parameters after 3265500 iterations
taking 24.7 minutes (multi-variate psrf = 1.064).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:14:02 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 10 parameters after 3285000 iterations
taking 24.9 minutes (multi-variate psrf = 1.227).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:14:13 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 4 parameters after 3304500 iterations
taking 25 minutes (multi-variate psrf = 1.089).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:14:21 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 7 parameters after 3324000 iterations
taking 25.2 minutes (multi-variate psrf = 1.149).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:14:32 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 3 parameters after 3343500 iterations
taking 25.3 minutes (multi-variate psrf = 1.067).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:14:43 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 9 parameters after 3363000 iterations
taking 25.5 minutes (multi-variate psrf = 1.279).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:14:51 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 10 parameters after 3382500 iterations
taking 25.6 minutes (multi-variate psrf = 1.12).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:14:59 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 9 parameters after 3402000 iterations
taking 25.8 minutes (multi-variate psrf = 1.205).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:15:09 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 6 parameters after 3421500 iterations
taking 25.9 minutes (multi-variate psrf = 1.081).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:15:20 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 6 parameters after 3441000 iterations
taking 26.1 minutes (multi-variate psrf = 1.027).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:15:28 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 2 parameters after 3460500 iterations
taking 26.2 minutes (multi-variate psrf = 1.015).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:15:36 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic is now below 1.05 for all parameters
Calculating the necessary sample length based on the Raftery and Lewis's diagnostic...
The model will need to be run for a further 121887 updates. This will take approximately 3.1
minutes.
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:15:44 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 365661
-------------------------------------------------| 365650
************************************************** 100%
* 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Indicated sample length achieved
Auto-run JAGS complete
Auto-run JAGS
Running a pilot chain...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:17:33 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. Updating 1500
-------------------------------------------------| 1500
************************************************** 100%
. . Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was above 1.05 for 12 parameters after 9000 iterations taking 11.3
seconds (multi-variate psrf = 1.238). This may indicate poor convergence.
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:17:44 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 28500 iterations
taking 21.7 seconds (multi-variate psrf = 1.59).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:17:55 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 48000 iterations
taking 31.9 seconds (multi-variate psrf = 1.634).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:18:05 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 67500 iterations
taking 42.1 seconds (multi-variate psrf = 1.602).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:18:16 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 87000 iterations
taking 52.4 seconds (multi-variate psrf = 1.088).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:18:27 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 106500 iterations
taking 1 minutes (multi-variate psrf = 1.188).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:18:37 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 126000 iterations
taking 1.2 minutes (multi-variate psrf = 1.063).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:18:45 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 145500 iterations
taking 1.3 minutes (multi-variate psrf = 1.199).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:18:56 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 165000 iterations
taking 1.5 minutes (multi-variate psrf = 1.736).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:19:07 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 184500 iterations
taking 1.7 minutes (multi-variate psrf = 1.583).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:19:17 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 204000 iterations
taking 1.9 minutes (multi-variate psrf = 2.881).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:19:28 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 223500 iterations
taking 2 minutes (multi-variate psrf = 1.439).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:19:39 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 243000 iterations
taking 2.2 minutes (multi-variate psrf = 1.808).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:19:50 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 262500 iterations
taking 2.4 minutes (multi-variate psrf = 1.255).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:20:01 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 6 parameters after 282000 iterations
taking 2.5 minutes (multi-variate psrf = 1.064).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:20:09 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 301500 iterations
taking 2.7 minutes (multi-variate psrf = 1.483).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:20:20 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic is now below 1.05 for all parameters
Calculating the necessary sample length based on the Raftery and Lewis's diagnostic...
The model will need to be run for a further 1268328 updates. This will take approximately
33.8 minutes.
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:20:29 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 3804984
-------------------------------------------------| 3804950
************************************************** 100%
* 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Indicated sample length achieved
Auto-run JAGS complete
Auto-run JAGS
Running a pilot chain...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:37:44 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. Updating 1500
-------------------------------------------------| 1500
************************************************** 100%
. . Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was above 1.05 for 4 parameters after 9000 iterations taking 10.5
seconds (multi-variate psrf = 1.101). This may indicate poor convergence.
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:37:55 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic is now below 1.05 for all parameters
Calculating the necessary sample length based on the Raftery and Lewis's diagnostic...
The model will need to be run for a further 2899263 updates. This will take approximately 1.2
hours.
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 19:38:04 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 8697789
-------------------------------------------------| 8697750
************************************************** 100%
* 100%
. . . . Updating 0
. Deleting model
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Indicated sample length achieved
Auto-run JAGS complete
Auto-run JAGS
Running a pilot chain...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 20:16:49 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. Updating 1500
-------------------------------------------------| 1500
************************************************** 100%
. . Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was above 1.05 for 12 parameters after 9000 iterations taking 10.4
seconds (multi-variate psrf = 1.302). This may indicate poor convergence.
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 20:16:59 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 28500 iterations
taking 20.8 seconds (multi-variate psrf = 1.188).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 20:17:10 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 12 parameters after 48000 iterations
taking 28 seconds (multi-variate psrf = 1.03).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 20:17:18 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
The Gelman-Rubin statistic was still above 1.05 for 2 parameters after 67500 iterations taking
35.5 seconds (multi-variate psrf = 1.001).
Extending the simulation to attempt to improve convergence...
Calling 2 simulations using the parallel method...
Following the progress of chain 1 (the program will wait for all chains to finish before
continuing):
Welcome to JAGS 4.3.1 on Wed May 24 20:17:25 2023
JAGS is free software and comes with ABSOLUTELY NO WARRANTY
Loading module: basemod: ok
Loading module: bugs: ok
. Loading module: glm: ok
. Loading module: dic: ok
. . Reading data file data.txt
. Compiling model graph
Resolving undeclared variables
Allocating nodes
Graph information:
Observed stochastic nodes: 76
Unobserved stochastic nodes: 134
Total graph size: 1042
. Reading parameter file inits1.txt
. Initializing model
. Adapting 1500
-------------------------------------------------| 1500
++++++++++++++++++++++++++++++++++++++++++++++++++ 100%
Adaptation successful
. NOTE: Stopping adaptation
. Updating 18000
-------------------------------------------------| 18000
************************************************** 100%
. . . . Updating 0
. Deleting model
.
All chains have finished
Simulation complete. Reading coda files...
Coda files loaded successfully
Finished running the simulation
Calculating the Gelman-Rubin statistic for 12 variables....
Error: An error occured while calculating the Gelman-Rubin statistic. Check that different chains have not been given the same starting values and random seeds, and that there is at least one stochastic monitored variable.