Init

library(kirkegaard)
## Loading required package: tidyverse
## ── Attaching core tidyverse packages ──────────────────────── tidyverse 2.0.0 ──
## ✔ dplyr     1.1.4     ✔ readr     2.1.5
## ✔ forcats   1.0.0     ✔ stringr   1.5.1
## ✔ ggplot2   3.5.2     ✔ tibble    3.2.1
## ✔ lubridate 1.9.4     ✔ tidyr     1.3.1
## ✔ purrr     1.0.4     
## ── Conflicts ────────────────────────────────────────── tidyverse_conflicts() ──
## ✖ dplyr::filter() masks stats::filter()
## ✖ dplyr::lag()    masks stats::lag()
## ℹ Use the conflicted package (<http://conflicted.r-lib.org/>) to force all conflicts to become errors
## Loading required package: magrittr
## 
## 
## Attaching package: 'magrittr'
## 
## 
## The following object is masked from 'package:purrr':
## 
##     set_names
## 
## 
## The following object is masked from 'package:tidyr':
## 
##     extract
## 
## 
## Loading required package: weights
## 
## Loading required package: Hmisc
## 
## 
## Attaching package: 'Hmisc'
## 
## 
## The following objects are masked from 'package:dplyr':
## 
##     src, summarize
## 
## 
## The following objects are masked from 'package:base':
## 
##     format.pval, units
## 
## 
## Loading required package: assertthat
## 
## 
## Attaching package: 'assertthat'
## 
## 
## The following object is masked from 'package:tibble':
## 
##     has_name
## 
## 
## Loading required package: psych
## 
## 
## Attaching package: 'psych'
## 
## 
## The following object is masked from 'package:Hmisc':
## 
##     describe
## 
## 
## The following objects are masked from 'package:ggplot2':
## 
##     %+%, alpha
## 
## 
## 
## Attaching package: 'kirkegaard'
## 
## 
## The following object is masked from 'package:psych':
## 
##     rescale
## 
## 
## The following object is masked from 'package:assertthat':
## 
##     are_equal
## 
## 
## The following object is masked from 'package:purrr':
## 
##     is_logical
## 
## 
## The following object is masked from 'package:base':
## 
##     +
load_packages(
  mirt,
  future,
  rms,
  ggeffects,
  polycor,
  ggcorrplot,
  mgcv,
  BMA
)
## Loading required package: stats4
## Loading required package: lattice
## 
## Attaching package: 'polycor'
## 
## The following object is masked from 'package:psych':
## 
##     polyserial
## 
## Loading required package: nlme
## 
## Attaching package: 'nlme'
## 
## The following object is masked from 'package:mirt':
## 
##     fixef
## 
## The following object is masked from 'package:dplyr':
## 
##     collapse
## 
## This is mgcv 1.9-1. For overview type 'help("mgcv-package")'.
## Loading required package: survival
## 
## Attaching package: 'survival'
## 
## The following object is masked from 'package:future':
## 
##     cluster
## 
## Loading required package: leaps
## Loading required package: robustbase
## 
## Attaching package: 'robustbase'
## 
## The following object is masked from 'package:survival':
## 
##     heart
## 
## Loading required package: inline
## Loading required package: rrcov
## Scalable Robust Estimators with High Breakdown Point (version 1.7-6)
## 
## 
## Attaching package: 'rrcov'
## 
## The following object is masked from 'package:nlme':
## 
##     getData
theme_set(theme_bw())

options(
    digits = 3
)

#future multi-threading
plan(multisession(workers = 4))
mirtCluster(4, remove = T)
## There is no visible mirtCluster() definition

Functions

plot_items = function(fit, p_value_adj = T, items = NULL, threshold = 0.05) {
  #input must be a list from DIF_test()
  assertthat::assert_that(is.list(fit))
  
  # browser()
  if (is.null(items)) {
    #get item ids if we want the biased items
    if (p_value_adj) {
      p_var = "p_adj"
    } else {
      p_var = "p"
    }
    item_idx = fit$DIF_stats %>% filter(.data[[p_var]] < threshold) %>% pull(number)
  }
  
  #if not empty
  if (length(item_idx) > 0) {
   plot(
    fit$fits$anchor_liberal,
    type = "trace",
    which.items = item_idx
    )
  } else {
    message("No items were biased")
  }
}

# plot_items(dif_irt_mh_diag)
# plot_items(dif_irt_mh_all)

# Function to calculate p-value matrix from r, SE, and n matrices (Grok 3)
cor_se_n_to_pvalue_matrix <- function(r_matrix, se_matrix, n_matrix) {
  # Check that all matrices have the same dimensions
  if (!identical(dim(r_matrix), dim(se_matrix)) || 
      !identical(dim(r_matrix), dim(n_matrix))) {
    stop("Correlation, SE, and n matrices must have the same dimensions")
  }
  
  # Initialize p-value matrix with same dimensions
  pval_matrix <- matrix(NA, nrow = nrow(r_matrix), ncol = ncol(r_matrix))
  rownames(pval_matrix) <- rownames(r_matrix)
  colnames(pval_matrix) <- colnames(r_matrix)
  
  # Calculate p-values for each element
  for (i in 1:nrow(r_matrix)) {
    for (j in 1:ncol(r_matrix)) {
      r <- r_matrix[i, j]
      se <- se_matrix[i, j]
      n <- n_matrix[i, j]
      
      # Skip if NA or if diagonal (r = 1, se = 0, n irrelevant)
      if (is.na(r) || is.na(se) || is.na(n) || (i == j)) {
        pval_matrix[i, j] <- ifelse(i == j, 0, NA)
      } else if (n < 3) {
        pval_matrix[i, j] <- NA  # Need at least 3 observations for df > 0
      } else {
        # Calculate t-statistic
        t_stat <- abs(r / se)
        
        # Degrees of freedom
        df <- n - 2
        
        # Two-tailed p-value
        pval_matrix[i, j] <- 2 * pt(-t_stat, df)
      }
    }
  }
  
  return(pval_matrix)
}

#test it
iris_cors = corr.test(iris[, 1:4])

cor_se_n_to_pvalue_matrix(iris_cors$r, iris_cors$se, matrix(iris_cors$n, ncol = 4, nrow = 4))
##              Sepal.Length Sepal.Width Petal.Length Petal.Width
## Sepal.Length     0.00e+00    1.52e-01     1.04e-47    2.33e-37
## Sepal.Width      1.52e-01    0.00e+00     4.51e-08    4.07e-06
## Petal.Length     1.04e-47    4.51e-08     0.00e+00    4.68e-86
## Petal.Width      2.33e-37    4.07e-06     4.68e-86    0.00e+00
corr.test(iris[, 1:4])$p
##              Sepal.Length Sepal.Width Petal.Length Petal.Width
## Sepal.Length     0.00e+00    1.52e-01     5.19e-47    9.30e-37
## Sepal.Width      1.52e-01    0.00e+00     1.35e-07    8.15e-06
## Petal.Length     1.04e-47    4.51e-08     0.00e+00    2.81e-85
## Petal.Width      2.33e-37    4.07e-06     4.68e-86    0.00e+00
#convenience function to plot a correlation matrix
plot_cor_mat = function(data, sig = 0.01) {
  #get cors using polycor
  cor_mat = polycor::hetcor(
    data %>% as.data.frame(), 
    use = "pairwise.complete.obs"
    )
  
  #get p-values
  cor_mat$p_mat = cor_se_n_to_pvalue_matrix(cor_mat$correlations, cor_mat$std.errors, cor_mat$n)
  
  #plot
  GG_heatmap(
    cor_mat$correlations,
    reorder_vars = F,
    cross_out_nonsig = T,
    pairwise_p = cor_mat$p_mat,
    short_x_labels = T
  )
}

#get DIF item counts by direction
get_DIF_counts = function(dif_fit, strict = T, threshold = 0.05) {

  #subsetting variable name
  if (strict) {
    sub = "conservative"
  } else {
    sub = "liberal"
  }
  
  #first join the tables so we can get directions
  dd = dif_fit$DIF_stats %>% 
    select(number, p_adj, p) %>% 
    inner_join(
      dif_irt_mh_all$effect_size_items[[sub]] %>% mutate(number = row_number()) %>% select(number, ESSD),
      by = "number"
    )
  
  #get counts
  if (strict) {
    dd2 = dd %>% 
      filter(p_adj < threshold)
  } else {
    dd2 = dd %>% 
      filter(p < threshold)
  }
  
  str_glue("{sum(dd2$ESSD > 0)} vs. {sum(dd2$ESSD < 0)}")
}

Data

#prolific metadata
d_prolific_r1 = read_csv("data/prolific_export_65bea717e88884f2a27d8b23.csv") %>% df_legalize_names()
## Rows: 559 Columns: 21
## ── Column specification ────────────────────────────────────────────────────────
## Delimiter: ","
## chr  (15): Submission id, Participant id, Status, Custom study tncs accepted...
## dbl   (2): Time taken, Total approvals
## dttm  (4): Started at, Completed at, Reviewed at, Archived at
## 
## ℹ Use `spec()` to retrieve the full column specification for this data.
## ℹ Specify the column types or set `show_col_types = FALSE` to quiet this message.
d_prolific_r2 = read_csv("data/prolific_export_67cecb794a8d3abf6de4ad0e r2.csv") %>% df_legalize_names()
## Rows: 538 Columns: 22
## ── Column specification ────────────────────────────────────────────────────────
## Delimiter: ","
## chr  (16): Submission id, Participant id, Status, Custom study tncs accepted...
## dbl   (2): Time taken, Total approvals
## lgl   (1): Reviewed at
## dttm  (3): Started at, Completed at, Archived at
## 
## ℹ Use `spec()` to retrieve the full column specification for this data.
## ℹ Specify the column types or set `show_col_types = FALSE` to quiet this message.
#overlap in ids
ids_overlap = intersect(d_prolific_r1$Participant_id, d_prolific_r2$Participant_id)
ids_overlap %>% length()
## [1] 9
#join and remove dups
#their data is the same, so we can just take the first
d_prolific = bind_rows(d_prolific_r1, d_prolific_r2) %>% filter(!duplicated(Participant_id))
assert_that(!anyDuplicated(d_prolific$Participant_id))
## [1] TRUE
#alchemer export
d_alchemer = read_csv("data/20250310151312-SurveyExport r2.csv") %>% df_legalize_names()
## New names:
## • `Time Spent on Page` -> `Time Spent on Page...48`
## • `Time Spent on Page` -> `Time Spent on Page...95`
## • `Time Spent on Page` -> `Time Spent on Page...104`
## • `Time Spent on Page` -> `Time Spent on Page...114`
## • `Time Spent on Page` -> `Time Spent on Page...121`
## • `Time Spent on Page` -> `Time Spent on Page...132`
## • `Time Spent on Page` -> `Time Spent on Page...138`
## • `Time Spent on Page` -> `Time Spent on Page...162`
## • `Other - Write In:Do you have a doctor's diagnoses for any of the following
##   mental illneses? Check all that apply, otherwise check "not struggling with
##   mental illness"` -> `Other - Write In:Do you have a doctor's diagnoses for
##   any of the following mental illneses? Check all that apply, otherwise check
##   "not struggling with mental illness"...241`
## • `Other - Write In:Do you have a doctor's diagnoses for any of the following
##   mental illneses? Check all that apply, otherwise check "not struggling with
##   mental illness"` -> `Other - Write In:Do you have a doctor's diagnoses for
##   any of the following mental illneses? Check all that apply, otherwise check
##   "not struggling with mental illness"...242`
## • `Time Spent on Page` -> `Time Spent on Page...245`
## Warning: One or more parsing issues, call `problems()` on your data frame for details,
## e.g.:
##   dat <- vroom(...)
##   problems(dat)
## Rows: 1100 Columns: 246
## ── Column specification ────────────────────────────────────────────────────────
## Delimiter: ","
## chr  (210): Status, Language, Referer, SessionID, User Agent, IP Address, Co...
## dbl   (30): Response ID, Longitude, Latitude, How old are you?, Father:What ...
## lgl    (4): Contact ID, Legacy Comments, Comments, Tags
## dttm   (2): Time Started, Date Submitted
## 
## ℹ Use `spec()` to retrieve the full column specification for this data.
## ℹ Specify the column types or set `show_col_types = FALSE` to quiet this message.
#overlap in ids
ids_overlap = intersect(d_prolific$Participant_id, d_alchemer$Prolific_ID)
ids_overlap %>% length()
## [1] 1052
#join by id
d = inner_join(
  d_prolific, 
  d_alchemer %>% filter(Status == "Complete"),
  by = c("Participant_id" = "Prolific_ID")
)

#how many dups?
d$Participant_id %>% table2(include_NA = F) %>% pull(Count) %>% table2(include_NA = F)
#drop dups
d = d %>% filter(!duplicated(Participant_id))

#no dups
assert_that(!anyDuplicated(d$Participant_id))
## [1] TRUE
#attention checks
d_attention = d %>% select(
  Pick_the_word_Firefly,
  Pick_the_name_Peter,
  Pick_the_word_Bottle,
  Pick_the_word_Chair
) %>% mutate(
  attention1 = Pick_the_word_Firefly == "Firefly",
  attention2 = Pick_the_name_Peter == "Peter",
  attention3 = Pick_the_word_Bottle == "Bottle",
  attention4 = Pick_the_word_Chair == "Chair",
  pass = attention1 & attention2 & attention3 & attention4
)

#add to main
d = bind_cols(
  d,
  d_attention %>% select(starts_with("attention"), pass)
)

d$pass %>% table2()
#which ids failed?
if (F) {
  d %>% filter(!pass) %>% select(Participant_id, attention1:attention4)
}

#discard non-pass cases
d %<>% filter(NA_to_X(pass, T))

#vars
d_vars = df_var_table(d)

Recoding

Others

#survey wave
d$survey_wave = d$Date_Submitted %>% year() %>% case_match(2024 ~ "wave 1", 2025 ~ "wave 2") %>% factor()
d$survey_wave %>% table2()
#age
d$age = d$Age %>% as.numeric()
## Warning in d$Age %>% as.numeric(): NAs introduced by coercion
d$age %>% describe2()
d$age_median_split = d$age %>% kirkegaard::discretize(2, equal_range = F, labels = "integer") %>% case_match(1 ~ "Young", 2 ~ "Old")
d$age_median_split %>% table2()
d$age_z = d$age %>% standardize()

#sex
d$sex = d$What_s_your_sex %>% case_match("Female (no Y chromosome)" ~ "Female", "Male (Y chromosome)" ~ "Male") %>% factor()
d$sex %>% table2()
d$male = (d$sex == "Male") %>% as.numeric()
d$female = !d$male

#race
d$race = d$Ethnicity_simplified
d$Ethnicity_simplified %>% table2()
#recode races into a combination
d$race2 = d %>% 
  select(Asian_What_is_your_race_or_ethnicity_Select_all_that_apply:Other_What_is_your_race_or_ethnicity_Select_all_that_apply) %>% 
  map_df(~str_remove_all(., "_What_is_your_race_or_ethnicity_Select_all_that_apply")) %>% 
  set_colnames(str_remove(colnames(.), "_What_is_your_race_or_ethnicity_Select_all_that_apply")) %>% 
  map_df(~!is.na(.)) %>% 
  encode_combinations()

d$race2 %>% table2()
#collapse into Hispanics with or without White
#others into Other
d$race2_common = d$race2 %>% case_match(
  c("Hispanic_Latino", "Hispanic_Latino, White") ~ "Hispanic",
  "White" ~ "White",
  "Black" ~ "Black",
  "Asian" ~ "Asian",
  .default = "Other"
) %>% fct_relevel("White")
d$race2_common %>% table2()
d$US_born = d$Country_of_birth %>% case_match(
  "United States" ~ T,
  "DATA_EXPIRED" ~ NA,
  .default = F
)
d$Country_of_birth %>% table2()
d$US_born %>% table2()
#tattoos
d$tattoos = d %>% select(Hand_On_which_parts_of_your_body_do_you_have_tattoos_If_you_don_t_have_any_select_I_don_t_have_any_tattoos:Other_On_which_parts_of_your_body_do_you_have_tattoos_If_you_don_t_have_any_select_I_don_t_have_any_tattoos) %>% 
  set_colnames(str_remove(colnames(.), "_On_which_parts_of_your_body_do_you_have_tattoos_If_you_don_t_have_any_select_I_don_t_have_any_tattoos")) %>%
  map_df(~str_remove_all(., "_On_which_parts_of_your_body_do_you_have_tattoos_If_you_don_t_have_any_select_I_don_t_have_any_tattoos")) %>%
  map_df(~!is.na(.)) %>%
  encode_combinations()

d$tattoos %<>% mapvalues("", "None")
d$tattoos %>% table2()
#lump
d$tattoos2 = d$tattoos %>% fct_lump_min(min = 5, other_level = "Other_or_multiple")
d$tattoos2 %>% table2()
d$tattoos_count = d %>% 
  select(Hand_On_which_parts_of_your_body_do_you_have_tattoos_If_you_don_t_have_any_select_I_don_t_have_any_tattoos:Other_On_which_parts_of_your_body_do_you_have_tattoos_If_you_don_t_have_any_select_I_don_t_have_any_tattoos) %>% 
  map_df(~!is.na(.)) %>%
  rowSums(na.rm = T)

d$tattoos_count %>% table2()
d$tattoos_count2 = d$tattoos_count %>% as.factor() %>% fct_lump_min(20, other_level = "5+")
d$tattoos_count2 %>% table2()
d$tattoos_any = d$tattoos_count > 0

#tattoo data
d_tats = d %>% 
  select(Hand_On_which_parts_of_your_body_do_you_have_tattoos_If_you_don_t_have_any_select_I_don_t_have_any_tattoos:Other_On_which_parts_of_your_body_do_you_have_tattoos_If_you_don_t_have_any_select_I_don_t_have_any_tattoos) %>%  
  map_df(~!is.na(.))

#fix names
colnames(d_tats) = d_tats %>% colnames() %>% str_remove_all("_On_which_parts_of_your_body_do_you_have_tattoos_If_you_don_t_have_any_select_I_don_t_have_any_tattoos")

#piercings
d$piercings = d %>% 
  select(Ears_Do_you_have_any_piercings_If_so_where_If_you_don_t_have_any_select_I_don_t_have_any_piercings:Other_Do_you_have_any_piercings_If_so_where_If_you_don_t_have_any_select_I_don_t_have_any_piercings) %>% 
  set_colnames(str_remove(colnames(.), "_Do_you_have_any_piercings_If_so_where_If_you_don_t_have_any_select_I_don_t_have_any_piercings")) %>%
  map_df(~str_remove_all(., "_Do_you_have_any_piercings_If_so_where_If_you_don_t_have_any_select_I_don_t_have_any_piercings")) %>%
  map_df(~!is.na(.)) %>%
  encode_combinations()

d$piercings %<>% mapvalues("", "None")
d$piercings %>% table2()
#lump
d$piercings2 = d$piercings %>% fct_lump_min(min = 5, other_level = "Other_or_multiple")
d$piercings2 %>% table2()
d$piercings_count = d %>% 
  select(Ears_Do_you_have_any_piercings_If_so_where_If_you_don_t_have_any_select_I_don_t_have_any_piercings:Other_Do_you_have_any_piercings_If_so_where_If_you_don_t_have_any_select_I_don_t_have_any_piercings) %>% 
  map_df(~!is.na(.)) %>%
  rowSums(na.rm = T)

d$piercings_count %>% table2()
d$piercings_count2 = d$piercings_count %>% as.factor() %>% fct_lump_min(20, other_level = "3+")
d$piercings_count2 %>% table2()
d$piercings_any = d$piercings_count > 0

#piercing data
d_piercings = d %>% 
  select(Ears_Do_you_have_any_piercings_If_so_where_If_you_don_t_have_any_select_I_don_t_have_any_piercings:Other_Do_you_have_any_piercings_If_so_where_If_you_don_t_have_any_select_I_don_t_have_any_piercings) %>%  
  map_df(~!is.na(.))

#fix names
colnames(d_piercings) = d_piercings %>% colnames() %>% str_remove_all("_Do_you_have_any_piercings_If_so_where_If_you_don_t_have_any_select_I_don_t_have_any_piercings")

#join to main
d = bind_cols(
  d,
  d_tats %>% df_add_affix("Tattoo_"),
  d_piercings %>% df_add_affix("Piercing_")
  )

#height
d$height = (d$Feet_How_tall_are_you_Barefooted %>% as.numeric() %>% multiply_by(30.48)) + (d$Inches_How_tall_are_you_Barefooted %>% as.numeric() %>% multiply_by(2.54))
d$height[d$height > 220] = NA #one person has invalid height data
d$weight = d$What_do_you_weigh_In_pounds %>% as.numeric() %>% multiply_by(0.453592)
d$BMI = d$weight / (d$height / 100)^2

d %>% select(height, weight, BMI) %>% describe2()
#hair color
d$unnatural_hair = (d$As_an_adult_have_you_ever_dyed_your_hair_with_an_unnatural_hair_color_pink_green_blue_purple_yellow_etc == "Yes") %>% as.factor()
d$unnatural_hair %>% table2()
#hair style
d$hair_styles = d %>% select(Straight_As_an_adult_check_the_hairstyles_you_have_ever_had:Skrillex_As_an_adult_check_the_hairstyles_you_have_ever_had) %>% 
  set_colnames(str_remove(colnames(.), "_As_an_adult_check_the_hairstyles_you_have_ever_had")) %>%
  map_df(~str_remove_all(., "_As_an_adult_check_the_hairstyles_you_have_ever_had")) %>%
  map_df(~!is.na(.)) %>%
  encode_combinations()

Mental health, happiness, satisfaction

#all mental health, happiness, vars
mh_vars = d %>% select(
  Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen_Answer_the_following_statements_with_a_yes_or_no:Using_any_of_the_following_medicines_ON_YOUR_OWN_that_is_without_a_doctor_s_prescription_in_greater_amounts_or_longer_than_prescribed_e_g_painkillers_like_Vicodin_stimulants_like_Ritalin_or_Adderall_sedatives_or_tranquilizers_like_sleeping_pills_or_Valium_or_drugs_like_marijuana_cocaine_or_crack_club_drugs_like_ecstasy_hallucinogens_like_LSD_heroin_inhalants_or_solvents_like_glue_or_methamphetamine_like_speed_During_the_past_TWO_2_WEEKS_how_much_or_how_often_have_you_been_bothered_by_the_following_problems,
  Life_satisfaction_How_would_you_rate_your:Sleeping_disorders_Do_you_have_a_doctor_s_diagnoses_for_any_of_the_following_mental_illneses_Check_all_that_apply_otherwise_check_not_struggling_with_mental_illness
) 

#recode bugs
mh_vars$I_feel_that_I_have_often_been_punished_without_cause_Answer_the_following_statements_with_a_yes_or_no %<>% NA_to_X("No")

#recode binary with NA as 0
for (v in names(mh_vars %>% select(Attention_deficit_hyperactivity_disorder_ADHD_Do_you_have_a_doctor_s_diagnoses_for_any_of_the_following_mental_illneses_Check_all_that_apply_otherwise_check_not_struggling_with_mental_illness:Sleeping_disorders_Do_you_have_a_doctor_s_diagnoses_for_any_of_the_following_mental_illneses_Check_all_that_apply_otherwise_check_not_struggling_with_mental_illness))) {
  mh_vars[[v]] = if_else(is.na(mh_vars[[v]]), 0, 1)
}

#figure out the scale for each
mh_vars_options = map_dfr(names(mh_vars), function(var) {
  #unique responses
  scale = unique(mh_vars[[var]])
  
  tibble(
    var = var, 
    options_chosen = list(scale),
    option_number = length(scale),
    itemtype = if_else(length(scale) == 2, "2PL", "graded")
    )
})

#recode into integers
#binary is easy, but ordinals we need to set levels first, annoying
mh_vars_num = mh_vars

#loop and recode
for (v in names(mh_vars)) {
  #binary: q's 39 and 44
  if (length(unique(mh_vars[[v]])) == 2) {
    mh_vars_num[[v]] = mh_vars_num[[v]] %>% as.factor() %>% as.numeric()
  }
  
  #last 2 weeks...
  #40. During the past TWO (2) WEEKS, how much (or how often) have you been bothered by the following problems? *
  if (str_detect(v, "TWO_2_WEEKS_how_much")) {
    mh_vars_num[[v]] = mh_vars_num[[v]] %>% factor(levels = c("None (Not at all)", "Slight (Rare, less than a day or two)", "Mild (Several days)", "Moderate (More than half the days)", "Severe (Nearly every day)")) %>% as.numeric()
  }
  
  #42. How would you rate your: *
  if (str_detect(v, "How_would_you_rate_you")) {
    mh_vars_num[[v]] = mh_vars_num[[v]] %>% as.numeric()
  }
  
  #43. How do you rate the following options? *
  if (str_detect(v, "How_do_you_rate_the_following_options")) {
    mh_vars_num[[v]] = mh_vars_num[[v]] %>% factor(levels = c("Strongly disagree", "Disagree", "Somewhat disagree", "Neutral", "Somewhat agree", "Agree", "Strongly agree")) %>% as.numeric()
  }
}

#ensure all are numeric
assert_that(all(map_lgl(mh_vars_num, is.numeric)))
## [1] TRUE
#simplify names
mh_vars_clean_names = colnames(mh_vars_num) %>% 
  str_remove("_How_would_you_rate_your") %>% 
  str_remove("_Do_you_have_a_doctor_s_diagnoses_for_any_of_the_following_mental_illneses_Check_all_that_apply_otherwise_check_not_struggling_with_mental_illness") %>%
  str_remove("_How_do_you_rate_the_following_options") %>% 
  str_remove("_During_the_past_TWO_2_WEEKS_how_much_or_how_often_have_you_been_bothered_by_the_following_problems") %>% 
  str_remove("_Answer_the_following_statements_with_a_yes_or_no") %>% 
  str_remove("_that_is_without_a_doctor_s_prescription_in_greater_amounts_or_longer_than_prescribed_e_g_painkillers_like_Vicodin_stimulants_like_Ritalin_or_Adderall_sedatives_or_tranquilizers_like_sleeping_pills_or_Valium_or_drugs_like_marijuana_cocaine_or_crack_club_drugs_like_ecstasy_hallucinogens_like_LSD_heroin_inhalants_or_solvents_like_glue_or_methamphetamine_like_speed") %>% 
  str_replace("Phobias_specific_for_example_agoraphobia_and_claustrophobia", "Specific_phobias")

#update names
colnames(mh_vars_num) = mh_vars_clean_names
mh_vars_options$clean_names = mh_vars_clean_names

#https://github.com/philchalmers/mirt/issues/267
#these caused a very odd test function that prevents proper analysis
#reverse positive MMPI items
#reverse the satisfaction items too
for (v in mh_vars_num %>% select(I_am_happy_most_of_the_time:I_get_all_the_sympathy_I_should, Life_satisfaction:If_I_could_live_my_life_over_I_would_change_almost_nothing) %>% colnames()) {
  mh_vars_num[[v]] = mh_vars_num[[v]] %>% reverse_scale()
}

#names of non-diagnoses
mh_vars_symptoms = mh_vars_num %>% select(-c(Attention_deficit_hyperactivity_disorder_ADHD:Sleeping_disorders)) %>% names()

Ideology, politics

pol_vars = d %>% select(
  #27. How much do you agree with the following statements? *
  There_are_objective_measures_of_beauty_How_much_do_you_agree_with_the_following_statements:Body_positivity_is_harmful_How_much_do_you_agree_with_the_following_statements,
  #28. How much do you agree with the following statements? *
  I_support_the_LGBT_community_How_much_do_you_agree_with_the_following_statements:Everyone_be_addressed_by_their_desired_pronouns_How_much_do_you_agree_with_the_following_statements,
  #29. How much do you agree with the following statements? *
  I_support_feminism_How_much_do_you_agree_with_the_following_statements:Abortion_should_be_available_to_women_for_use_for_any_reason_How_much_do_you_agree_with_the_following_statements,
  #30. How much do you agree with the following statements? *
  I_support_sending_more_aid_to_Ukraine_How_much_do_you_agree_with_the_following_statements:Israel_is_commiting_genocide_in_Gaza_How_much_do_you_agree_with_the_following_statements,
  #31. How much do you agree with the following statements? *
  Black_Lives_Matter_is_a_virtuous_organization_How_much_do_you_agree_with_the_following_statements:Racial_diversity_is_more_important_than_viewpoint_diversity_How_much_do_you_agree_with_the_following_statements,
  #34. How much do you agree with the following statements? *
  The_world_is_suffering_from_overpopulation_How_much_do_you_agree_with_the_following_statements:Public_policy_changes_do_not_need_to_be_made_to_deal_with_climate_change_How_much_do_you_agree_with_the_following_statements,
  #37. What is your party registration? *
  # What_is_your_party_registration,
  #38. Are you politically left-wing or right-wing? *
  Are_you_politically_left_wing_or_right_wing
)

#figure out the scale for each
pol_vars_options = map_dfr(names(pol_vars), function(var) {
  #unique responses
  scale = unique(pol_vars[[var]])
  
  tibble(
    var = var, 
    options_chosen = list(scale),
    option_number = length(scale),
    itemtype = if_else(length(scale) == 2, "2PL", "graded")
    )
})

#recode into integers
#binary is easy, but ordinals we need to set levels first, annoying
pol_vars_num = pol_vars

#loop and recode
for (v in names(pol_vars)) {
  #27. How much do you agree with the following statements? *
  if (str_detect(v, "How_much_do_you_agree_with_the_following_statements")) {
    pol_vars_num[[v]] = pol_vars_num[[v]] %>% str_to_lower() %>% factor(levels = c("strongly disagree", "disagree", "somewhat disagree", "neutral", "somewhat agree", "agree", "strongly agree")) %>% as.numeric()
  }
  
  #37. What is your party registration? *
  if (str_detect(v, "What_is_your_party_registration")) {
    pol_vars_num[[v]] = pol_vars_num[[v]] %>% factor(levels = c("Democrat", "Republican", "Independent", "Other - Write In")) %>% as.numeric()
  }
  
  #38. Are you politically left-wing or right-wing? *
  if (str_detect(v, "Are_you_politically_left_wing_or_right_wing")) {
    pol_vars_num[[v]] = pol_vars_num[[v]] %>% as.numeric()
  }
}

#recode one to nominal
# pol_vars_options$itemtype[41] = "nominal"

Analysis

Other

#collection time
d$Completed_at
##   [1] "2024-02-16 01:36:25 UTC" "2024-02-16 01:50:43 UTC"
##   [3] "2024-02-16 01:38:27 UTC" "2024-02-16 01:46:27 UTC"
##   [5] "2024-02-16 01:47:12 UTC" "2024-02-16 01:48:30 UTC"
##   [7] "2024-02-16 01:48:18 UTC" "2024-02-16 01:54:03 UTC"
##   [9] "2024-02-16 02:05:07 UTC" "2024-02-16 02:00:14 UTC"
##  [11] "2024-02-16 02:16:40 UTC" "2024-02-16 01:58:06 UTC"
##  [13] "2024-02-16 02:45:18 UTC" "2024-02-16 02:38:14 UTC"
##  [15] "2024-02-16 02:50:05 UTC" "2024-02-16 02:46:28 UTC"
##  [17] "2024-02-16 02:44:38 UTC" "2024-02-16 02:44:27 UTC"
##  [19] "2024-02-16 03:06:54 UTC" "2024-02-16 04:05:18 UTC"
##  [21] "2024-02-16 03:59:58 UTC" "2024-02-16 04:04:36 UTC"
##  [23] "2024-02-16 04:05:06 UTC" "2024-02-16 04:02:30 UTC"
##  [25] "2024-02-16 04:04:13 UTC" "2024-02-16 04:15:24 UTC"
##  [27] "2024-02-16 04:01:55 UTC" "2024-02-16 04:12:19 UTC"
##  [29] "2024-02-16 04:10:13 UTC" "2024-02-16 04:18:43 UTC"
##  [31] "2024-02-16 04:27:25 UTC" "2024-02-16 04:20:48 UTC"
##  [33] "2024-02-16 04:17:57 UTC" "2024-02-16 04:18:19 UTC"
##  [35] "2024-02-16 04:22:53 UTC" "2024-02-16 04:14:31 UTC"
##  [37] "2024-02-16 04:23:10 UTC" "2024-02-16 04:36:58 UTC"
##  [39] "2024-02-16 04:20:54 UTC" "2024-02-16 04:25:26 UTC"
##  [41] "2024-02-16 04:33:19 UTC" "2024-02-16 04:25:02 UTC"
##  [43] "2024-02-16 04:20:32 UTC" "2024-02-16 04:37:37 UTC"
##  [45] "2024-02-16 04:40:32 UTC" "2024-02-16 04:20:17 UTC"
##  [47] "2024-02-16 04:27:55 UTC" "2024-02-16 04:30:15 UTC"
##  [49] "2024-02-16 04:25:45 UTC" "2024-02-16 04:29:55 UTC"
##  [51] "2024-02-16 04:33:12 UTC" "2024-02-16 04:32:10 UTC"
##  [53] "2024-02-16 04:26:59 UTC" "2024-02-16 04:33:49 UTC"
##  [55] "2024-02-16 04:32:32 UTC" "2024-02-16 04:30:47 UTC"
##  [57] "2024-02-16 04:34:15 UTC" "2024-02-16 04:59:14 UTC"
##  [59] "2024-02-16 04:38:52 UTC" "2024-02-16 04:45:30 UTC"
##  [61] "2024-02-16 04:44:02 UTC" "2024-02-16 04:44:19 UTC"
##  [63] "2024-02-16 05:06:58 UTC" "2024-02-16 04:46:08 UTC"
##  [65] "2024-02-16 04:35:57 UTC" "2024-02-16 04:38:07 UTC"
##  [67] "2024-02-16 05:29:08 UTC" "2024-02-16 04:47:50 UTC"
##  [69] "2024-02-16 04:43:09 UTC" "2024-02-16 04:51:57 UTC"
##  [71] "2024-02-16 04:59:42 UTC" "2024-02-16 04:43:05 UTC"
##  [73] "2024-02-16 04:44:32 UTC" "2024-02-16 04:48:01 UTC"
##  [75] "2024-02-16 04:40:43 UTC" "2024-02-16 04:43:46 UTC"
##  [77] "2024-02-16 04:46:25 UTC" "2024-02-16 04:46:46 UTC"
##  [79] "2024-02-16 05:00:09 UTC" "2024-02-16 04:48:22 UTC"
##  [81] "2024-02-16 04:50:20 UTC" "2024-02-16 04:52:10 UTC"
##  [83] "2024-02-16 04:56:13 UTC" "2024-02-16 05:15:19 UTC"
##  [85] "2024-02-16 04:53:13 UTC" "2024-02-16 04:56:26 UTC"
##  [87] "2024-02-16 04:48:59 UTC" "2024-02-16 05:00:19 UTC"
##  [89] "2024-02-16 05:05:23 UTC" "2024-02-16 05:07:09 UTC"
##  [91] "2024-02-16 05:00:46 UTC" "2024-02-16 04:59:34 UTC"
##  [93] "2024-02-16 04:59:01 UTC" "2024-02-16 04:58:03 UTC"
##  [95] "2024-02-16 05:06:35 UTC" "2024-02-16 05:10:16 UTC"
##  [97] "2024-02-16 04:56:45 UTC" "2024-02-16 05:07:41 UTC"
##  [99] "2024-02-16 04:57:04 UTC" "2024-02-16 05:38:31 UTC"
## [101] "2024-02-16 04:59:01 UTC" "2024-02-16 05:10:27 UTC"
## [103] "2024-02-16 05:00:58 UTC" "2024-02-16 05:08:07 UTC"
## [105] "2024-02-16 05:03:09 UTC" "2024-02-16 05:11:20 UTC"
## [107] "2024-02-16 05:01:19 UTC" "2024-02-16 04:59:13 UTC"
## [109] "2024-02-16 05:42:06 UTC" "2024-02-16 05:03:28 UTC"
## [111] "2024-02-16 05:02:31 UTC" "2024-02-16 05:05:46 UTC"
## [113] "2024-02-16 05:11:30 UTC" "2024-02-16 05:12:16 UTC"
## [115] "2024-02-16 05:11:21 UTC" "2024-02-16 05:06:59 UTC"
## [117] "2024-02-16 05:05:13 UTC" "2024-02-16 05:20:43 UTC"
## [119] "2024-02-16 05:19:16 UTC" "2024-02-16 05:45:04 UTC"
## [121] "2024-02-16 05:11:18 UTC" "2024-02-16 05:10:39 UTC"
## [123] "2024-02-16 05:21:36 UTC" "2024-02-16 05:07:37 UTC"
## [125] "2024-02-16 05:14:10 UTC" "2024-02-16 05:09:48 UTC"
## [127] "2024-02-16 05:22:34 UTC" "2024-02-16 05:20:07 UTC"
## [129] "2024-02-16 05:11:15 UTC" "2024-02-16 05:23:40 UTC"
## [131] "2024-02-16 05:40:01 UTC" "2024-02-16 05:17:48 UTC"
## [133] "2024-02-16 05:38:25 UTC" "2024-02-16 05:10:03 UTC"
## [135] "2024-02-16 05:23:03 UTC" "2024-02-16 05:12:58 UTC"
## [137] "2024-02-16 05:19:33 UTC" "2024-02-16 05:25:36 UTC"
## [139] "2024-02-16 05:25:53 UTC" "2024-02-16 05:33:25 UTC"
## [141] "2024-02-16 05:22:15 UTC" "2024-02-16 05:14:56 UTC"
## [143] "2024-02-16 05:18:02 UTC" "2024-02-16 05:14:41 UTC"
## [145] "2024-02-16 05:14:33 UTC" "2024-02-16 05:35:35 UTC"
## [147] "2024-02-16 05:13:44 UTC" "2024-02-16 05:28:54 UTC"
## [149] "2024-02-16 05:22:20 UTC" "2024-02-16 05:45:59 UTC"
## [151] "2024-02-16 05:22:24 UTC" "2024-02-16 05:18:07 UTC"
## [153] "2024-02-16 05:21:21 UTC" "2024-02-16 05:17:10 UTC"
## [155] "2024-02-16 05:32:05 UTC" "2024-02-16 05:18:40 UTC"
## [157] "2024-02-16 05:22:35 UTC" "2024-02-16 05:26:27 UTC"
## [159] "2024-02-16 05:33:55 UTC" "2024-02-16 05:29:35 UTC"
## [161] "2024-02-16 05:29:18 UTC" "2024-02-16 05:29:13 UTC"
## [163] "2024-02-16 05:29:53 UTC" "2024-02-16 05:26:05 UTC"
## [165] "2024-02-16 05:21:43 UTC" "2024-02-16 05:35:47 UTC"
## [167] "2024-02-16 05:20:22 UTC" "2024-02-16 05:23:49 UTC"
## [169] "2024-02-16 05:28:45 UTC" "2024-02-16 05:27:43 UTC"
## [171] "2024-02-16 05:22:35 UTC" "2024-02-16 05:20:48 UTC"
## [173] "2024-02-16 05:28:01 UTC" "2024-02-16 05:28:24 UTC"
## [175] "2024-02-16 05:22:16 UTC" "2024-02-16 05:31:09 UTC"
## [177] "2024-02-16 05:27:00 UTC" "2024-02-16 05:25:13 UTC"
## [179] "2024-02-16 05:33:03 UTC" "2024-02-16 05:29:39 UTC"
## [181] "2024-02-16 05:32:16 UTC" "2024-02-16 05:46:46 UTC"
## [183] "2024-02-16 05:30:19 UTC" "2024-02-16 05:27:39 UTC"
## [185] "2024-02-16 05:32:53 UTC" "2024-02-16 05:26:21 UTC"
## [187] "2024-02-16 05:53:54 UTC" "2024-02-16 05:26:18 UTC"
## [189] "2024-02-16 05:36:55 UTC" "2024-02-16 06:20:44 UTC"
## [191] "2024-02-16 05:29:31 UTC" "2024-02-16 05:32:14 UTC"
## [193] "2024-02-16 05:34:47 UTC" "2024-02-16 05:32:43 UTC"
## [195] "2024-02-16 05:33:10 UTC" "2024-02-16 05:36:02 UTC"
## [197] "2024-02-16 05:36:55 UTC" "2024-02-16 05:34:45 UTC"
## [199] "2024-02-16 05:39:24 UTC" "2024-02-16 05:45:06 UTC"
## [201] "2024-02-16 05:57:30 UTC" "2024-02-16 05:35:37 UTC"
## [203] "2024-02-16 05:42:43 UTC" "2024-02-16 05:46:15 UTC"
## [205] "2024-02-16 05:44:43 UTC" "2024-02-16 05:29:38 UTC"
## [207] "2024-02-16 05:58:08 UTC" NA                       
## [209] "2024-02-16 05:42:42 UTC" "2024-02-16 05:43:43 UTC"
## [211] "2024-02-16 05:50:52 UTC" "2024-02-16 05:37:13 UTC"
## [213] "2024-02-16 05:34:59 UTC" "2024-02-16 05:44:25 UTC"
## [215] "2024-02-16 05:31:31 UTC" "2024-02-16 05:32:24 UTC"
## [217] "2024-02-16 05:41:18 UTC" "2024-02-16 05:40:36 UTC"
## [219] "2024-02-16 05:39:27 UTC" "2024-02-16 05:37:43 UTC"
## [221] "2024-02-16 05:35:17 UTC" "2024-02-16 05:39:58 UTC"
## [223] "2024-02-16 05:48:48 UTC" "2024-02-16 05:44:48 UTC"
## [225] "2024-02-16 05:42:03 UTC" "2024-02-16 05:41:40 UTC"
## [227] "2024-02-16 05:43:24 UTC" "2024-02-16 05:49:11 UTC"
## [229] "2024-02-16 05:39:46 UTC" "2024-02-16 05:43:17 UTC"
## [231] "2024-02-16 05:36:24 UTC" "2024-02-16 05:43:44 UTC"
## [233] "2024-02-16 05:58:16 UTC" "2024-02-16 05:53:02 UTC"
## [235] "2024-02-16 05:39:46 UTC" "2024-02-16 05:50:17 UTC"
## [237] NA                        "2024-02-16 05:47:25 UTC"
## [239] "2024-02-16 05:41:28 UTC" "2024-02-16 05:52:26 UTC"
## [241] "2024-02-16 05:46:41 UTC" "2024-02-16 05:45:14 UTC"
## [243] "2024-02-16 05:48:37 UTC" "2024-02-16 06:01:10 UTC"
## [245] "2024-02-16 05:51:07 UTC" "2024-02-16 05:51:05 UTC"
## [247] "2024-02-16 06:12:14 UTC" "2024-02-16 05:56:55 UTC"
## [249] "2024-02-16 05:46:13 UTC" "2024-02-16 05:45:21 UTC"
## [251] "2024-02-16 05:45:25 UTC" "2024-02-16 05:45:22 UTC"
## [253] "2024-02-16 05:46:30 UTC" "2024-02-16 06:06:58 UTC"
## [255] "2024-02-16 05:49:01 UTC" "2024-02-16 05:46:07 UTC"
## [257] "2024-02-16 05:46:33 UTC" "2024-02-16 05:49:40 UTC"
## [259] "2024-02-16 05:51:21 UTC" "2024-02-16 05:54:51 UTC"
## [261] "2024-02-16 05:55:10 UTC" "2024-02-16 05:49:59 UTC"
## [263] "2024-02-16 05:57:35 UTC" "2024-02-16 05:49:33 UTC"
## [265] "2024-02-16 05:48:23 UTC" "2024-02-16 05:50:21 UTC"
## [267] "2024-02-16 05:48:49 UTC" "2024-02-16 05:57:02 UTC"
## [269] "2024-02-16 05:57:18 UTC" "2024-02-16 05:52:27 UTC"
## [271] "2024-02-16 06:13:25 UTC" "2024-02-16 05:56:16 UTC"
## [273] "2024-02-16 05:58:41 UTC" "2024-02-16 05:53:05 UTC"
## [275] "2024-02-16 05:55:51 UTC" "2024-02-16 05:47:50 UTC"
## [277] "2024-02-16 05:54:52 UTC" "2024-02-16 06:02:11 UTC"
## [279] "2024-02-16 06:31:32 UTC" "2024-02-16 05:48:24 UTC"
## [281] "2024-02-16 05:53:25 UTC" "2024-02-16 05:54:00 UTC"
## [283] "2024-02-16 05:50:18 UTC" "2024-02-16 06:05:58 UTC"
## [285] "2024-02-16 06:02:33 UTC" "2024-02-16 05:51:42 UTC"
## [287] "2024-02-16 05:54:57 UTC" "2024-02-16 05:55:57 UTC"
## [289] "2024-02-16 06:08:20 UTC" "2024-02-16 05:55:11 UTC"
## [291] "2024-02-16 05:51:03 UTC" "2024-02-16 05:53:43 UTC"
## [293] "2024-02-16 06:08:05 UTC" "2024-02-16 06:00:37 UTC"
## [295] "2024-02-16 05:58:50 UTC" "2024-02-16 06:16:47 UTC"
## [297] "2024-02-16 05:58:14 UTC" "2024-02-16 05:57:39 UTC"
## [299] "2024-02-16 06:04:09 UTC" "2024-02-16 05:53:12 UTC"
## [301] "2024-02-16 05:59:33 UTC" "2024-02-16 05:59:48 UTC"
## [303] "2024-02-16 05:56:53 UTC" "2024-02-16 06:01:47 UTC"
## [305] "2024-02-16 05:56:24 UTC" "2024-02-16 06:19:36 UTC"
## [307] "2024-02-16 05:58:07 UTC" "2024-02-16 06:09:36 UTC"
## [309] "2024-02-16 05:57:16 UTC" "2024-02-16 06:03:03 UTC"
## [311] "2024-02-16 05:56:49 UTC" "2024-02-16 06:05:55 UTC"
## [313] "2024-02-16 05:58:19 UTC" "2024-02-16 06:16:38 UTC"
## [315] "2024-02-16 06:07:14 UTC" "2024-02-16 05:59:50 UTC"
## [317] "2024-02-16 05:58:42 UTC" "2024-02-16 06:15:51 UTC"
## [319] "2024-02-16 06:05:50 UTC" "2024-02-16 06:01:34 UTC"
## [321] "2024-02-16 06:09:50 UTC" "2024-02-16 06:29:06 UTC"
## [323] "2024-02-16 06:09:50 UTC" "2024-02-16 06:10:58 UTC"
## [325] "2024-02-16 06:07:39 UTC" "2024-02-16 06:14:08 UTC"
## [327] "2024-02-16 06:02:58 UTC" "2024-02-16 06:06:25 UTC"
## [329] "2024-02-16 06:02:42 UTC" "2024-02-16 06:07:41 UTC"
## [331] "2024-02-16 06:15:21 UTC" "2024-02-16 06:20:24 UTC"
## [333] "2024-02-16 06:28:50 UTC" "2024-02-16 06:04:53 UTC"
## [335] "2024-02-16 06:39:36 UTC" "2024-02-16 06:07:28 UTC"
## [337] "2024-02-16 06:16:08 UTC" "2024-02-16 06:07:18 UTC"
## [339] "2024-02-16 06:13:54 UTC" "2024-02-16 06:12:00 UTC"
## [341] "2024-02-16 06:10:26 UTC" "2024-02-16 06:37:25 UTC"
## [343] "2024-02-16 06:20:20 UTC" "2024-02-16 06:20:42 UTC"
## [345] "2024-02-16 06:17:48 UTC" "2024-02-16 06:17:02 UTC"
## [347] "2024-02-16 06:16:16 UTC" "2024-02-16 06:14:33 UTC"
## [349] "2024-02-16 06:11:10 UTC" "2024-02-16 06:16:13 UTC"
## [351] "2024-02-16 06:11:13 UTC" "2024-02-16 06:33:24 UTC"
## [353] "2024-02-16 06:11:45 UTC" "2024-02-16 06:18:19 UTC"
## [355] "2024-02-16 06:18:02 UTC" "2024-02-16 06:18:17 UTC"
## [357] "2024-02-16 06:25:37 UTC" "2024-02-16 06:20:18 UTC"
## [359] "2024-02-16 06:20:26 UTC" "2024-02-16 06:14:38 UTC"
## [361] "2024-02-16 06:20:08 UTC" "2024-02-16 06:15:10 UTC"
## [363] "2024-02-16 06:29:37 UTC" "2024-02-16 06:21:15 UTC"
## [365] "2024-02-16 06:23:46 UTC" "2024-02-16 06:19:14 UTC"
## [367] "2024-02-16 06:21:03 UTC" "2024-02-16 06:23:04 UTC"
## [369] "2024-02-16 06:20:57 UTC" "2024-02-16 06:21:54 UTC"
## [371] "2024-02-16 06:17:52 UTC" "2024-02-16 06:26:08 UTC"
## [373] "2024-02-16 06:20:07 UTC" "2024-02-16 06:29:46 UTC"
## [375] "2024-02-16 06:52:32 UTC" "2024-02-16 06:29:46 UTC"
## [377] "2024-02-16 06:31:42 UTC" "2024-02-16 06:38:42 UTC"
## [379] "2024-02-16 06:42:32 UTC" "2024-02-16 06:34:46 UTC"
## [381] "2024-02-16 08:14:21 UTC" "2024-02-16 06:41:46 UTC"
## [383] "2024-02-16 06:49:17 UTC" "2024-02-16 06:37:19 UTC"
## [385] "2024-02-16 06:36:42 UTC" "2024-02-16 06:37:01 UTC"
## [387] "2024-02-16 06:42:39 UTC" "2024-02-16 06:51:30 UTC"
## [389] "2024-02-16 06:47:33 UTC" "2024-02-16 06:47:45 UTC"
## [391] "2024-02-16 06:46:51 UTC" "2024-02-16 06:40:11 UTC"
## [393] "2024-02-16 07:06:25 UTC" "2024-02-16 06:41:25 UTC"
## [395] "2024-02-16 06:54:40 UTC" "2024-02-16 06:46:45 UTC"
## [397] "2024-02-16 07:01:10 UTC" "2024-02-16 06:52:45 UTC"
## [399] "2024-02-16 06:58:29 UTC" "2024-02-16 06:50:00 UTC"
## [401] "2024-02-16 06:45:06 UTC" "2024-02-16 06:41:50 UTC"
## [403] "2024-02-16 06:52:33 UTC" "2024-02-16 06:59:25 UTC"
## [405] "2024-02-16 07:00:13 UTC" "2024-02-16 07:06:43 UTC"
## [407] "2024-02-16 06:59:18 UTC" "2024-02-16 07:06:13 UTC"
## [409] "2024-02-16 07:19:50 UTC" "2024-02-16 06:52:59 UTC"
## [411] "2024-02-16 07:07:45 UTC" "2024-02-16 07:09:16 UTC"
## [413] "2024-02-16 07:06:02 UTC" "2024-02-16 07:16:40 UTC"
## [415] "2024-02-16 07:31:42 UTC" "2024-02-16 07:07:12 UTC"
## [417] "2024-02-16 07:30:37 UTC" "2024-02-16 07:22:40 UTC"
## [419] "2024-02-16 07:25:08 UTC" "2024-02-16 07:29:30 UTC"
## [421] "2024-02-16 07:21:01 UTC" "2024-02-16 07:17:09 UTC"
## [423] "2024-02-16 07:22:28 UTC" "2024-02-16 07:19:28 UTC"
## [425] "2024-02-16 07:21:43 UTC" "2024-02-16 07:30:10 UTC"
## [427] "2024-02-16 07:20:56 UTC" NA                       
## [429] "2024-02-16 07:21:53 UTC" "2024-02-16 07:26:29 UTC"
## [431] "2024-02-16 07:31:31 UTC" "2024-02-16 07:40:03 UTC"
## [433] "2024-02-16 07:38:44 UTC" "2024-02-16 07:32:48 UTC"
## [435] "2024-02-16 07:36:22 UTC" "2024-02-16 07:36:58 UTC"
## [437] "2024-02-16 07:52:32 UTC" "2024-02-16 07:38:28 UTC"
## [439] "2024-02-16 07:46:52 UTC" "2024-02-16 07:57:51 UTC"
## [441] "2024-02-16 07:58:28 UTC" "2024-02-16 08:00:18 UTC"
## [443] "2024-02-16 08:14:12 UTC" "2024-02-16 08:19:50 UTC"
## [445] "2024-02-16 08:00:32 UTC" "2024-02-16 08:22:01 UTC"
## [447] "2024-02-16 08:08:39 UTC" "2024-02-16 08:21:36 UTC"
## [449] "2024-02-16 08:29:31 UTC" "2024-02-16 08:29:59 UTC"
## [451] "2024-02-16 08:19:23 UTC" "2024-02-16 08:27:07 UTC"
## [453] "2024-02-16 08:52:56 UTC" "2024-02-16 08:34:27 UTC"
## [455] "2024-02-16 08:32:19 UTC" "2024-02-16 08:29:43 UTC"
## [457] "2024-02-16 08:43:15 UTC" "2024-02-16 08:32:26 UTC"
## [459] "2024-02-16 08:51:04 UTC" "2024-02-16 08:32:45 UTC"
## [461] "2024-02-16 08:32:59 UTC" "2024-02-16 08:30:42 UTC"
## [463] "2024-02-16 08:35:50 UTC" "2024-02-16 08:42:46 UTC"
## [465] "2024-02-16 09:02:12 UTC" "2024-02-16 08:45:53 UTC"
## [467] "2024-02-16 09:06:26 UTC" "2024-02-16 08:48:29 UTC"
## [469] "2024-02-16 08:54:29 UTC" "2024-02-16 08:43:51 UTC"
## [471] "2024-02-16 08:56:28 UTC" "2024-02-16 08:59:30 UTC"
## [473] "2024-02-16 08:59:18 UTC" "2024-02-16 09:19:36 UTC"
## [475] "2024-02-16 09:01:10 UTC" "2024-02-16 09:05:19 UTC"
## [477] "2024-02-16 09:05:20 UTC" "2024-02-16 09:06:51 UTC"
## [479] "2024-02-16 09:05:04 UTC" "2024-02-16 09:13:58 UTC"
## [481] NA                        "2024-02-16 09:16:54 UTC"
## [483] "2024-02-16 09:19:31 UTC" "2024-02-16 09:39:54 UTC"
## [485] "2024-02-16 09:44:01 UTC" "2024-02-16 09:50:46 UTC"
## [487] "2024-02-16 09:51:56 UTC" "2024-02-16 09:58:55 UTC"
## [489] "2024-02-16 10:07:14 UTC" "2024-02-16 10:06:55 UTC"
## [491] "2024-02-16 10:09:48 UTC" "2024-02-16 10:12:56 UTC"
## [493] "2024-02-16 10:00:30 UTC" "2024-02-16 11:13:28 UTC"
## [495] "2024-02-16 12:00:28 UTC" "2024-02-16 13:57:53 UTC"
## [497] "2025-03-10 11:50:33 UTC" "2025-03-10 11:41:40 UTC"
## [499] "2025-03-10 11:43:03 UTC" "2025-03-10 11:59:46 UTC"
## [501] "2025-03-10 12:30:36 UTC" "2025-03-10 12:03:14 UTC"
## [503] "2025-03-10 12:10:13 UTC" "2025-03-10 11:49:35 UTC"
## [505] "2025-03-10 11:46:56 UTC" "2025-03-10 11:52:34 UTC"
## [507] "2025-03-10 11:52:41 UTC" "2025-03-10 11:54:43 UTC"
## [509] "2025-03-10 11:51:47 UTC" "2025-03-10 11:52:08 UTC"
## [511] "2025-03-10 11:49:53 UTC" "2025-03-10 12:04:26 UTC"
## [513] "2025-03-10 11:56:47 UTC" "2025-03-10 11:47:57 UTC"
## [515] "2025-03-10 11:55:21 UTC" "2025-03-10 11:49:57 UTC"
## [517] "2025-03-10 11:52:17 UTC" "2025-03-10 11:50:41 UTC"
## [519] "2025-03-10 11:56:55 UTC" "2025-03-10 11:54:33 UTC"
## [521] "2025-03-10 11:55:46 UTC" "2025-03-10 12:00:46 UTC"
## [523] "2025-03-10 11:53:18 UTC" "2025-03-10 11:54:22 UTC"
## [525] "2025-03-10 12:14:24 UTC" "2025-03-10 11:58:06 UTC"
## [527] "2025-03-10 11:58:28 UTC" "2025-03-10 11:49:21 UTC"
## [529] "2025-03-10 11:48:51 UTC" "2025-03-10 12:07:52 UTC"
## [531] "2025-03-10 11:59:18 UTC" "2025-03-10 11:52:53 UTC"
## [533] "2025-03-10 11:58:37 UTC" "2025-03-10 12:12:08 UTC"
## [535] "2025-03-10 11:55:57 UTC" "2025-03-10 11:53:14 UTC"
## [537] "2025-03-10 11:56:51 UTC" "2025-03-10 12:06:53 UTC"
## [539] "2025-03-10 11:57:59 UTC" "2025-03-10 12:10:41 UTC"
## [541] "2025-03-10 11:56:40 UTC" "2025-03-10 12:07:31 UTC"
## [543] "2025-03-10 11:59:51 UTC" "2025-03-10 11:56:08 UTC"
## [545] "2025-03-10 11:55:05 UTC" "2025-03-10 12:07:13 UTC"
## [547] "2025-03-10 11:55:36 UTC" "2025-03-10 12:38:04 UTC"
## [549] "2025-03-10 11:57:25 UTC" "2025-03-10 12:14:00 UTC"
## [551] "2025-03-10 11:58:38 UTC" "2025-03-10 12:05:42 UTC"
## [553] "2025-03-10 12:02:26 UTC" "2025-03-10 12:07:15 UTC"
## [555] "2025-03-10 11:57:17 UTC" "2025-03-10 12:00:55 UTC"
## [557] "2025-03-10 12:10:12 UTC" "2025-03-10 12:07:35 UTC"
## [559] "2025-03-10 12:00:33 UTC" "2025-03-10 11:55:56 UTC"
## [561] "2025-03-10 12:09:07 UTC" "2025-03-10 11:56:46 UTC"
## [563] "2025-03-10 12:03:21 UTC" "2025-03-10 12:10:41 UTC"
## [565] "2025-03-10 11:59:13 UTC" "2025-03-10 11:56:04 UTC"
## [567] "2025-03-10 11:58:52 UTC" "2025-03-10 12:06:59 UTC"
## [569] "2025-03-10 12:01:55 UTC" "2025-03-10 11:56:31 UTC"
## [571] "2025-03-10 12:03:01 UTC" "2025-03-10 12:05:24 UTC"
## [573] "2025-03-10 12:07:30 UTC" "2025-03-10 12:26:44 UTC"
## [575] "2025-03-10 12:13:39 UTC" "2025-03-10 12:03:57 UTC"
## [577] "2025-03-10 12:00:13 UTC" "2025-03-10 12:03:16 UTC"
## [579] "2025-03-10 12:26:00 UTC" "2025-03-10 12:07:22 UTC"
## [581] "2025-03-10 12:21:42 UTC" "2025-03-10 11:58:29 UTC"
## [583] "2025-03-10 12:04:52 UTC" "2025-03-10 12:21:56 UTC"
## [585] "2025-03-10 12:04:18 UTC" "2025-03-10 12:02:59 UTC"
## [587] "2025-03-10 12:08:59 UTC" "2025-03-10 12:08:08 UTC"
## [589] "2025-03-10 12:13:40 UTC" "2025-03-10 12:00:57 UTC"
## [591] "2025-03-10 12:29:36 UTC" "2025-03-10 12:24:40 UTC"
## [593] "2025-03-10 12:30:11 UTC" "2025-03-10 12:31:12 UTC"
## [595] "2025-03-10 12:32:20 UTC" "2025-03-10 12:26:47 UTC"
## [597] "2025-03-10 12:31:52 UTC" "2025-03-10 12:24:42 UTC"
## [599] "2025-03-10 12:30:20 UTC" "2025-03-10 12:45:04 UTC"
## [601] "2025-03-10 13:02:57 UTC" "2025-03-10 12:34:35 UTC"
## [603] "2025-03-10 12:28:12 UTC" "2025-03-10 12:27:18 UTC"
## [605] "2025-03-10 12:31:51 UTC" "2025-03-10 12:45:23 UTC"
## [607] "2025-03-10 12:34:40 UTC" "2025-03-10 12:29:32 UTC"
## [609] "2025-03-10 12:25:10 UTC" "2025-03-10 12:42:04 UTC"
## [611] "2025-03-10 12:25:14 UTC" "2025-03-10 12:54:36 UTC"
## [613] "2025-03-10 12:33:57 UTC" "2025-03-10 12:29:56 UTC"
## [615] "2025-03-10 12:31:42 UTC" "2025-03-10 12:39:48 UTC"
## [617] "2025-03-10 12:44:33 UTC" "2025-03-10 12:29:48 UTC"
## [619] "2025-03-10 12:56:31 UTC" "2025-03-10 12:45:40 UTC"
## [621] "2025-03-10 12:35:29 UTC" "2025-03-10 12:53:55 UTC"
## [623] "2025-03-10 12:32:50 UTC" "2025-03-10 12:50:52 UTC"
## [625] "2025-03-10 12:29:43 UTC" "2025-03-10 12:37:37 UTC"
## [627] "2025-03-10 12:34:47 UTC" "2025-03-10 12:46:14 UTC"
## [629] "2025-03-10 12:34:13 UTC" "2025-03-10 12:45:19 UTC"
## [631] "2025-03-10 13:09:17 UTC" "2025-03-10 12:56:20 UTC"
## [633] "2025-03-10 13:12:00 UTC" "2025-03-10 12:34:30 UTC"
## [635] "2025-03-10 12:49:35 UTC" "2025-03-10 13:04:49 UTC"
## [637] "2025-03-10 12:42:07 UTC" "2025-03-10 12:51:46 UTC"
## [639] "2025-03-10 12:39:27 UTC" "2025-03-10 13:03:59 UTC"
## [641] "2025-03-10 12:37:15 UTC" "2025-03-10 12:38:32 UTC"
## [643] "2025-03-10 12:45:10 UTC" "2025-03-10 12:35:34 UTC"
## [645] "2025-03-10 12:41:14 UTC" "2025-03-10 12:33:13 UTC"
## [647] "2025-03-10 12:41:21 UTC" "2025-03-10 12:49:54 UTC"
## [649] "2025-03-10 12:42:40 UTC" "2025-03-10 12:39:34 UTC"
## [651] "2025-03-10 12:39:15 UTC" "2025-03-10 12:37:04 UTC"
## [653] "2025-03-10 12:34:35 UTC" "2025-03-10 12:47:28 UTC"
## [655] "2025-03-10 12:42:24 UTC" "2025-03-10 12:47:10 UTC"
## [657] "2025-03-10 12:41:13 UTC" "2025-03-10 12:38:38 UTC"
## [659] "2025-03-10 12:51:14 UTC" "2025-03-10 12:40:22 UTC"
## [661] "2025-03-10 12:40:52 UTC" "2025-03-10 12:37:46 UTC"
## [663] "2025-03-10 12:36:36 UTC" "2025-03-10 12:45:17 UTC"
## [665] "2025-03-10 12:44:09 UTC" "2025-03-10 12:43:05 UTC"
## [667] "2025-03-10 12:43:38 UTC" "2025-03-10 12:36:18 UTC"
## [669] "2025-03-10 12:38:12 UTC" "2025-03-10 12:37:19 UTC"
## [671] "2025-03-10 12:48:38 UTC" "2025-03-10 12:41:37 UTC"
## [673] "2025-03-10 12:52:57 UTC" "2025-03-10 12:37:19 UTC"
## [675] "2025-03-10 12:44:27 UTC" "2025-03-10 12:44:40 UTC"
## [677] "2025-03-10 12:52:35 UTC" "2025-03-10 12:54:17 UTC"
## [679] "2025-03-10 13:25:42 UTC" "2025-03-10 13:00:56 UTC"
## [681] "2025-03-10 13:07:28 UTC" "2025-03-10 12:51:46 UTC"
## [683] "2025-03-10 13:07:08 UTC" "2025-03-10 12:41:47 UTC"
## [685] "2025-03-10 12:49:29 UTC" "2025-03-10 12:48:45 UTC"
## [687] "2025-03-10 12:49:04 UTC" "2025-03-10 12:42:49 UTC"
## [689] "2025-03-10 12:49:40 UTC" "2025-03-10 12:47:38 UTC"
## [691] "2025-03-10 12:44:40 UTC" "2025-03-10 13:02:26 UTC"
## [693] "2025-03-10 12:57:42 UTC" "2025-03-10 12:45:49 UTC"
## [695] "2025-03-10 12:49:59 UTC" "2025-03-10 12:54:24 UTC"
## [697] "2025-03-10 13:02:25 UTC" "2025-03-10 13:14:26 UTC"
## [699] "2025-03-10 12:57:15 UTC" "2025-03-10 12:48:26 UTC"
## [701] "2025-03-10 12:51:42 UTC" "2025-03-10 12:52:02 UTC"
## [703] "2025-03-10 12:57:29 UTC" "2025-03-10 12:47:10 UTC"
## [705] "2025-03-10 12:50:16 UTC" "2025-03-10 13:10:50 UTC"
## [707] "2025-03-10 12:51:33 UTC" "2025-03-10 13:00:44 UTC"
## [709] "2025-03-10 12:48:18 UTC" "2025-03-10 12:52:25 UTC"
## [711] "2025-03-10 12:54:11 UTC" "2025-03-10 12:49:04 UTC"
## [713] "2025-03-10 12:52:21 UTC" "2025-03-10 12:52:21 UTC"
## [715] "2025-03-10 12:51:39 UTC" "2025-03-10 12:47:26 UTC"
## [717] "2025-03-10 12:47:55 UTC" "2025-03-10 12:51:11 UTC"
## [719] "2025-03-10 13:22:54 UTC" "2025-03-10 13:06:42 UTC"
## [721] "2025-03-10 12:57:49 UTC" "2025-03-10 13:39:22 UTC"
## [723] "2025-03-10 12:52:10 UTC" "2025-03-10 13:08:21 UTC"
## [725] "2025-03-10 12:58:19 UTC" "2025-03-10 12:53:06 UTC"
## [727] "2025-03-10 13:11:13 UTC" "2025-03-10 12:52:09 UTC"
## [729] "2025-03-10 12:52:50 UTC" "2025-03-10 12:50:12 UTC"
## [731] "2025-03-10 12:53:19 UTC" "2025-03-10 13:03:17 UTC"
## [733] "2025-03-10 13:01:54 UTC" "2025-03-10 13:14:48 UTC"
## [735] "2025-03-10 13:08:18 UTC" "2025-03-10 13:06:36 UTC"
## [737] "2025-03-10 12:57:01 UTC" "2025-03-10 12:57:01 UTC"
## [739] "2025-03-10 12:53:12 UTC" "2025-03-10 13:14:36 UTC"
## [741] "2025-03-10 13:05:36 UTC" "2025-03-10 13:08:12 UTC"
## [743] "2025-03-10 12:57:24 UTC" "2025-03-10 12:52:57 UTC"
## [745] "2025-03-10 12:58:10 UTC" "2025-03-10 13:08:42 UTC"
## [747] "2025-03-10 12:59:54 UTC" "2025-03-10 12:53:41 UTC"
## [749] "2025-03-10 13:03:27 UTC" "2025-03-10 13:15:28 UTC"
## [751] "2025-03-10 13:34:49 UTC" "2025-03-10 13:01:06 UTC"
## [753] "2025-03-10 12:59:29 UTC" "2025-03-10 13:02:51 UTC"
## [755] "2025-03-10 13:00:21 UTC" "2025-03-10 12:59:20 UTC"
## [757] "2025-03-10 13:13:40 UTC" "2025-03-10 13:03:08 UTC"
## [759] "2025-03-10 13:06:28 UTC" "2025-03-10 12:58:40 UTC"
## [761] "2025-03-10 13:09:39 UTC" "2025-03-10 13:09:33 UTC"
## [763] "2025-03-10 13:14:52 UTC" "2025-03-10 13:03:55 UTC"
## [765] "2025-03-10 13:03:08 UTC" "2025-03-10 13:29:39 UTC"
## [767] "2025-03-10 13:47:26 UTC" "2025-03-10 13:06:58 UTC"
## [769] "2025-03-10 13:01:05 UTC" "2025-03-10 13:14:11 UTC"
## [771] "2025-03-10 13:03:38 UTC" "2025-03-10 13:03:39 UTC"
## [773] "2025-03-10 13:44:26 UTC" "2025-03-10 13:06:56 UTC"
## [775] "2025-03-10 13:07:05 UTC" "2025-03-10 13:23:08 UTC"
## [777] "2025-03-10 13:04:57 UTC" "2025-03-10 13:06:14 UTC"
## [779] "2025-03-10 13:15:03 UTC" "2025-03-10 13:23:43 UTC"
## [781] "2025-03-10 13:01:10 UTC" "2025-03-10 13:13:28 UTC"
## [783] "2025-03-10 13:13:57 UTC" "2025-03-10 13:17:26 UTC"
## [785] "2025-03-10 13:14:58 UTC" "2025-03-10 13:08:15 UTC"
## [787] "2025-03-10 13:20:28 UTC" "2025-03-10 13:30:34 UTC"
## [789] "2025-03-10 13:14:30 UTC" "2025-03-10 13:10:47 UTC"
## [791] "2025-03-10 13:08:30 UTC" "2025-03-10 13:16:01 UTC"
## [793] "2025-03-10 13:11:15 UTC" "2025-03-10 13:14:19 UTC"
## [795] "2025-03-10 13:13:02 UTC" "2025-03-10 13:10:19 UTC"
## [797] "2025-03-10 13:14:17 UTC" "2025-03-10 13:18:23 UTC"
## [799] "2025-03-10 13:23:21 UTC" "2025-03-10 13:30:53 UTC"
## [801] "2025-03-10 13:22:34 UTC" "2025-03-10 13:15:21 UTC"
## [803] "2025-03-10 13:22:57 UTC" "2025-03-10 13:19:44 UTC"
## [805] "2025-03-10 13:12:47 UTC" "2025-03-10 13:16:18 UTC"
## [807] "2025-03-10 13:15:00 UTC" "2025-03-10 13:15:04 UTC"
## [809] "2025-03-10 13:12:45 UTC" "2025-03-10 13:26:31 UTC"
## [811] "2025-03-10 13:23:22 UTC" "2025-03-10 13:25:02 UTC"
## [813] "2025-03-10 13:53:01 UTC" "2025-03-10 13:12:41 UTC"
## [815] "2025-03-10 13:11:27 UTC" "2025-03-10 13:29:22 UTC"
## [817] "2025-03-10 13:31:35 UTC" "2025-03-10 13:21:55 UTC"
## [819] "2025-03-10 13:44:54 UTC" "2025-03-10 13:12:08 UTC"
## [821] "2025-03-10 13:40:34 UTC" "2025-03-10 13:13:52 UTC"
## [823] "2025-03-10 13:38:09 UTC" "2025-03-10 13:46:25 UTC"
## [825] "2025-03-10 13:14:17 UTC" "2025-03-10 13:20:42 UTC"
## [827] "2025-03-10 13:16:31 UTC" "2025-03-10 13:13:24 UTC"
## [829] "2025-03-10 13:56:55 UTC" "2025-03-10 13:28:31 UTC"
## [831] "2025-03-10 13:46:54 UTC" "2025-03-10 13:29:19 UTC"
## [833] "2025-03-10 13:20:29 UTC" "2025-03-10 13:23:45 UTC"
## [835] "2025-03-10 13:47:26 UTC" "2025-03-10 13:26:41 UTC"
## [837] "2025-03-10 13:40:34 UTC" "2025-03-10 13:23:56 UTC"
## [839] "2025-03-10 13:30:09 UTC" "2025-03-10 13:24:31 UTC"
## [841] "2025-03-10 13:23:42 UTC" "2025-03-10 13:42:53 UTC"
## [843] "2025-03-10 13:26:44 UTC" "2025-03-10 13:22:14 UTC"
## [845] "2025-03-10 13:35:37 UTC" "2025-03-10 13:25:30 UTC"
## [847] "2025-03-10 13:32:50 UTC" "2025-03-10 13:26:35 UTC"
## [849] "2025-03-10 14:14:06 UTC" "2025-03-10 13:27:56 UTC"
## [851] "2025-03-10 13:23:50 UTC" "2025-03-10 14:03:39 UTC"
## [853] "2025-03-10 13:27:22 UTC" "2025-03-10 13:20:08 UTC"
## [855] "2025-03-10 13:25:17 UTC" "2025-03-10 14:05:09 UTC"
## [857] "2025-03-10 13:32:35 UTC" "2025-03-10 13:51:26 UTC"
## [859] "2025-03-10 13:47:25 UTC" "2025-03-10 14:05:43 UTC"
## [861] "2025-03-10 13:40:35 UTC" "2025-03-10 13:31:04 UTC"
## [863] "2025-03-10 13:33:30 UTC" "2025-03-10 13:34:36 UTC"
## [865] "2025-03-10 13:26:20 UTC" "2025-03-10 13:25:00 UTC"
## [867] "2025-03-10 13:28:00 UTC" "2025-03-10 14:08:20 UTC"
## [869] "2025-03-10 13:34:40 UTC" "2025-03-10 13:34:34 UTC"
## [871] "2025-03-10 13:33:23 UTC" "2025-03-10 13:28:12 UTC"
## [873] "2025-03-10 13:35:23 UTC" "2025-03-10 13:26:57 UTC"
## [875] "2025-03-10 13:41:52 UTC" "2025-03-10 14:00:10 UTC"
## [877] "2025-03-10 13:32:32 UTC" "2025-03-10 13:35:48 UTC"
## [879] "2025-03-10 14:01:34 UTC" "2025-03-10 13:45:47 UTC"
## [881] "2025-03-10 13:36:38 UTC" "2025-03-10 14:08:15 UTC"
## [883] "2025-03-10 13:31:34 UTC" "2025-03-10 13:36:24 UTC"
## [885] "2025-03-10 13:35:29 UTC" "2025-03-10 13:33:23 UTC"
## [887] "2025-03-10 13:28:42 UTC" "2025-03-10 13:34:26 UTC"
## [889] "2025-03-10 13:45:46 UTC" "2025-03-10 13:34:15 UTC"
## [891] "2025-03-10 13:36:20 UTC" "2025-03-10 13:32:18 UTC"
## [893] "2025-03-10 13:37:25 UTC" "2025-03-10 13:35:25 UTC"
## [895] "2025-03-10 13:38:25 UTC" "2025-03-10 13:39:08 UTC"
## [897] "2025-03-10 13:34:19 UTC" "2025-03-10 13:54:02 UTC"
## [899] "2025-03-10 13:36:28 UTC" "2025-03-10 13:52:52 UTC"
## [901] "2025-03-10 13:47:27 UTC" "2025-03-10 13:34:42 UTC"
## [903] "2025-03-10 13:47:11 UTC" "2025-03-10 13:37:10 UTC"
## [905] "2025-03-10 13:47:11 UTC" "2025-03-10 14:18:09 UTC"
## [907] "2025-03-10 13:51:44 UTC" "2025-03-10 13:36:46 UTC"
## [909] "2025-03-10 13:33:19 UTC" "2025-03-10 13:51:37 UTC"
## [911] "2025-03-10 13:59:15 UTC" "2025-03-10 13:44:22 UTC"
## [913] "2025-03-10 13:44:47 UTC" "2025-03-10 13:40:18 UTC"
## [915] "2025-03-10 13:41:56 UTC" "2025-03-10 13:43:38 UTC"
## [917] "2025-03-10 13:52:08 UTC" "2025-03-10 13:39:24 UTC"
## [919] "2025-03-10 13:57:24 UTC" "2025-03-10 13:47:15 UTC"
## [921] "2025-03-10 13:38:13 UTC" "2025-03-10 13:47:17 UTC"
## [923] "2025-03-10 13:42:01 UTC" "2025-03-10 13:58:04 UTC"
## [925] "2025-03-10 14:20:59 UTC" "2025-03-10 13:42:35 UTC"
## [927] "2025-03-10 13:40:13 UTC" "2025-03-10 13:48:52 UTC"
## [929] "2025-03-10 13:42:41 UTC" "2025-03-10 13:51:40 UTC"
## [931] "2025-03-10 13:45:06 UTC" "2025-03-10 13:54:57 UTC"
## [933] "2025-03-10 13:42:30 UTC" "2025-03-10 13:47:14 UTC"
## [935] "2025-03-10 13:47:42 UTC" "2025-03-10 13:47:21 UTC"
## [937] "2025-03-10 13:47:33 UTC" "2025-03-10 13:43:21 UTC"
## [939] "2025-03-10 14:14:59 UTC" "2025-03-10 13:48:00 UTC"
## [941] "2025-03-10 14:02:12 UTC" "2025-03-10 13:49:23 UTC"
## [943] "2025-03-10 14:03:06 UTC" "2025-03-10 13:57:35 UTC"
## [945] "2025-03-10 13:48:40 UTC" "2025-03-10 13:55:02 UTC"
## [947] "2025-03-10 13:50:42 UTC" "2025-03-10 14:06:32 UTC"
## [949] "2025-03-10 13:50:35 UTC" "2025-03-10 13:47:27 UTC"
## [951] "2025-03-10 13:52:03 UTC" "2025-03-10 13:57:56 UTC"
## [953] "2025-03-10 14:00:01 UTC" "2025-03-10 13:55:13 UTC"
## [955] "2025-03-10 13:52:37 UTC" "2025-03-10 13:59:29 UTC"
## [957] "2025-03-10 13:59:30 UTC" "2025-03-10 13:58:09 UTC"
## [959] "2025-03-10 14:00:37 UTC" "2025-03-10 14:00:59 UTC"
## [961] "2025-03-10 14:00:23 UTC" "2025-03-10 14:02:18 UTC"
## [963] "2025-03-10 14:41:46 UTC" "2025-03-10 14:09:55 UTC"
## [965] "2025-03-10 14:01:53 UTC" "2025-03-10 14:10:13 UTC"
## [967] "2025-03-10 14:14:55 UTC" "2025-03-10 14:17:57 UTC"
## [969] "2025-03-10 14:32:33 UTC" "2025-03-10 14:30:01 UTC"
## [971] "2025-03-10 14:55:17 UTC" "2025-03-10 15:11:58 UTC"
## [973] "2025-03-10 14:47:26 UTC" "2025-03-10 14:45:19 UTC"
## [975] "2025-03-10 14:44:57 UTC" "2025-03-10 15:03:16 UTC"
## [977] NA                        NA

Mental health

Dimensionality

How many factors should

#unidimensionality of total item pool
(unidem_all = unidim(
  mh_vars_num,
  cor = "mixed"
))
## Warning in polychoric(data[, p], smooth = smooth, global = global, weight =
## weight, : The items do not have an equal number of response alternatives,
## global set to FALSE.
## Warning in matpLower(x, nvar, gminx, gmaxx, gminy, gmaxy): 271 cells were
## adjusted for 0 values using the correction for continuity. Examine your data
## carefully.
## Warning in cor.smooth(mat): Matrix was not positive definite, smoothing was
## done
## Warning in polydi(data[, p, drop = FALSE], data[, d, drop = FALSE], global =
## global, : The items do not have an equal number of response alternatives, I am
## setting global to FALSE
## In smc, smcs > 1 were set to 1.0
## In smc, smcs < 0 were set to .0
## In smc, smcs > 1 were set to 1.0
## In smc, smcs < 0 were set to .0
## In smc, smcs > 1 were set to 1.0
## In smc, smcs < 0 were set to .0
## Warning in cor.smooth(r): Matrix was not positive definite, smoothing was done
## Warning in fa.stats(r = r, f = f, phi = phi, n.obs = n.obs, np.obs = np.obs, :
## The estimated weights for the factor scores are probably incorrect.  Try a
## different factor score estimation method.
## In smc, smcs > 1 were set to 1.0
## In smc, smcs < 0 were set to .0
## In smc, smcs > 1 were set to 1.0
## In smc, smcs < 0 were set to .0
## In smc, smcs > 1 were set to 1.0
## In smc, smcs < 0 were set to .0
## Warning in cor.smooth(r): Matrix was not positive definite, smoothing was done
## Warning in cor.smooth(r): The estimated weights for the factor scores are
## probably incorrect.  Try a different factor score estimation method.
## 
## A measure of unidimensionality 
##  Call: unidim(keys = mh_vars_num, cor = "mixed")
## 
## Unidimensionality index = 
##        u      tau    rho_c    alpha     av.r median.r      CFI      ECV 
##     0.74     0.81     0.91     0.98     0.37     0.37     0.11     0.73 
##    F1/F2      MAP 
##     4.04     0.04 
## 
## unidim adjusted index reverses negatively scored items.
## alpha    Based upon reverse scoring some items.
## average and median  correlations are based upon reversed scored items
#without diagnoses
(unidem_symptoms = unidim(
  #subset to non-diagnoses
  mh_vars_num %>% select(all_of(mh_vars_symptoms)),
  cor = "mixed"
))
## Warning in polychoric(data[, p], smooth = smooth, global = global, weight =
## weight, : The items do not have an equal number of response alternatives,
## global set to FALSE.
## Warning in matpLower(x, nvar, gminx, gmaxx, gminy, gmaxy): 271 cells were
## adjusted for 0 values using the correction for continuity. Examine your data
## carefully.
## Warning in polydi(data[, p, drop = FALSE], data[, d, drop = FALSE], global =
## global, : The items do not have an equal number of response alternatives, I am
## setting global to FALSE
## In smc, smcs > 1 were set to 1.0
## In smc, smcs > 1 were set to 1.0
## In smc, smcs > 1 were set to 1.0
## Warning in cor.smooth(r): Matrix was not positive definite, smoothing was done
## In smc, smcs > 1 were set to 1.0
## In smc, smcs > 1 were set to 1.0
## In smc, smcs > 1 were set to 1.0
## Warning in cor.smooth(r): Matrix was not positive definite, smoothing was done
## 
## A measure of unidimensionality 
##  Call: unidim(keys = mh_vars_num %>% select(all_of(mh_vars_symptoms)), 
##     cor = "mixed")
## 
## Unidimensionality index = 
##        u      tau    rho_c    alpha     av.r median.r      CFI      ECV 
##     0.80     0.85     0.93     0.98     0.44     0.45     0.32     0.77 
##    F1/F2      MAP 
##     3.99     0.05 
## 
## unidim adjusted index reverses negatively scored items.
## alpha    Based upon reverse scoring some items.
## average and median  correlations are based upon reversed scored items
#diagnoses only
(unidem_diag = unidim(
  #subset to diagnoses
  mh_vars_num %>% select(-all_of(mh_vars_symptoms)),
  cor = "mixed"
))
## Warning in cor.smooth(mat): Matrix was not positive definite, smoothing was
## done
## In smc, smcs < 0 were set to .0
## In smc, smcs < 0 were set to .0
## In smc, smcs < 0 were set to .0
## In smc, smcs < 0 were set to .0
## In smc, smcs < 0 were set to .0
## In smc, smcs < 0 were set to .0
## 
## A measure of unidimensionality 
##  Call: unidim(keys = mh_vars_num %>% select(-all_of(mh_vars_symptoms)), 
##     cor = "mixed")
## 
## Unidimensionality index = 
##        u      tau    rho_c    alpha     av.r median.r      CFI      ECV 
##     0.75     0.84     0.89     0.92     0.39     0.40     0.07     0.71 
##    F1/F2      MAP 
##     3.91     0.07 
## 
## unidim adjusted index reverses negatively scored items.
## alpha    Based upon reverse scoring some items.
## average and median  correlations are based upon reversed scored items
#MMPI items
(unidem_mmpi = unidim(
  mh_vars_num %>% select(
    Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen:I_get_all_the_sympathy_I_should
  ),
  cor = "mixed"
))
## 
## A measure of unidimensionality 
##  Call: unidim(keys = mh_vars_num %>% select(Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen:I_get_all_the_sympathy_I_should), 
##     cor = "mixed")
## 
## Unidimensionality index = 
##        u      tau    rho_c    alpha     av.r median.r      CFI      ECV 
##     0.91     0.94     0.97     0.96     0.51     0.51     0.66     0.83 
##    F1/F2      MAP 
##     6.16     0.04 
## 
## unidim adjusted index reverses negatively scored items.
## alpha    Based upon reverse scoring some items.
## average and median  correlations are based upon reversed scored items
#last 2 weeks items
(unidem_last2weeks = unidim(
  mh_vars_num %>% select(
    Little_interest_or_pleasure_in_doing_things:Using_any_of_the_following_medicines_ON_YOUR_OWN
  ),
  cor = "mixed"
))
## 
## A measure of unidimensionality 
##  Call: unidim(keys = mh_vars_num %>% select(Little_interest_or_pleasure_in_doing_things:Using_any_of_the_following_medicines_ON_YOUR_OWN), 
##     cor = "mixed")
## 
## Unidimensionality index = 
##        u      tau    rho_c    alpha     av.r median.r      CFI      ECV 
##     0.91     0.93     0.98     0.96     0.54     0.56     0.73     0.84 
##    F1/F2      MAP 
##     6.33     0.04 
## 
## unidim adjusted index reverses negatively scored items.
## alpha    Based upon reverse scoring some items.
## average and median  correlations are based upon reversed scored items
#satisfaction questions
(unidem_satisfaction = unidim(
  mh_vars_num %>% select(
    Life_satisfaction:If_I_could_live_my_life_over_I_would_change_almost_nothing
  ),
  cor = "mixed"
))
## 
## A measure of unidimensionality 
##  Call: unidim(keys = mh_vars_num %>% select(Life_satisfaction:If_I_could_live_my_life_over_I_would_change_almost_nothing), 
##     cor = "mixed")
## 
## Unidimensionality index = 
##        u      tau    rho_c    alpha     av.r median.r      CFI      ECV 
##     0.93     0.93     1.00     0.95     0.63     0.65     0.92     0.92 
##    F1/F2      MAP 
##     8.44     0.04 
## 
## unidim adjusted index reverses negatively scored items.
## alpha    Based upon reverse scoring some items.
## average and median  correlations are based upon reversed scored items

All items

#fit a full model with all items of all types
irt_mh_all = mirt(
  mh_vars_num,
  itemtype = mh_vars_options$itemtype,
  model = 1
)
## Iteration: 1, Log-Lik: -51797.639, Max-Change: 3.06912Iteration: 2, Log-Lik: -50535.681, Max-Change: 1.16805Iteration: 3, Log-Lik: -50221.225, Max-Change: 0.55674Iteration: 4, Log-Lik: -50117.205, Max-Change: 0.24880Iteration: 5, Log-Lik: -50078.822, Max-Change: 0.20982Iteration: 6, Log-Lik: -50054.489, Max-Change: 0.06360Iteration: 7, Log-Lik: -50035.161, Max-Change: 0.07342Iteration: 8, Log-Lik: -50018.900, Max-Change: 0.08285Iteration: 9, Log-Lik: -50004.027, Max-Change: 0.05465Iteration: 10, Log-Lik: -49992.228, Max-Change: 0.06575Iteration: 11, Log-Lik: -49983.017, Max-Change: 0.04286Iteration: 12, Log-Lik: -49976.229, Max-Change: 0.04002Iteration: 13, Log-Lik: -49970.457, Max-Change: 0.04316Iteration: 14, Log-Lik: -49964.805, Max-Change: 0.06165Iteration: 15, Log-Lik: -49961.667, Max-Change: 0.02534Iteration: 16, Log-Lik: -49959.452, Max-Change: 0.03687Iteration: 17, Log-Lik: -49956.212, Max-Change: 0.02704Iteration: 18, Log-Lik: -49953.691, Max-Change: 0.02741Iteration: 19, Log-Lik: -49948.867, Max-Change: 0.02920Iteration: 20, Log-Lik: -49947.373, Max-Change: 0.02266Iteration: 21, Log-Lik: -49945.731, Max-Change: 0.02293Iteration: 22, Log-Lik: -49942.636, Max-Change: 0.01909Iteration: 23, Log-Lik: -49941.597, Max-Change: 0.03700Iteration: 24, Log-Lik: -49940.906, Max-Change: 0.01757Iteration: 25, Log-Lik: -49940.519, Max-Change: 0.02880Iteration: 26, Log-Lik: -49939.839, Max-Change: 0.01409Iteration: 27, Log-Lik: -49939.441, Max-Change: 0.01814Iteration: 28, Log-Lik: -49938.847, Max-Change: 0.01274Iteration: 29, Log-Lik: -49938.347, Max-Change: 0.01971Iteration: 30, Log-Lik: -49937.922, Max-Change: 0.01291Iteration: 31, Log-Lik: -49937.467, Max-Change: 0.01153Iteration: 32, Log-Lik: -49937.149, Max-Change: 0.00905Iteration: 33, Log-Lik: -49936.862, Max-Change: 0.00868Iteration: 34, Log-Lik: -49936.002, Max-Change: 0.01003Iteration: 35, Log-Lik: -49935.712, Max-Change: 0.00655Iteration: 36, Log-Lik: -49935.555, Max-Change: 0.00638Iteration: 37, Log-Lik: -49935.220, Max-Change: 0.00552Iteration: 38, Log-Lik: -49935.092, Max-Change: 0.00509Iteration: 39, Log-Lik: -49934.983, Max-Change: 0.00514Iteration: 40, Log-Lik: -49934.733, Max-Change: 0.00461Iteration: 41, Log-Lik: -49934.644, Max-Change: 0.00511Iteration: 42, Log-Lik: -49934.552, Max-Change: 0.00354Iteration: 43, Log-Lik: -49934.350, Max-Change: 0.00390Iteration: 44, Log-Lik: -49934.271, Max-Change: 0.00327Iteration: 45, Log-Lik: -49934.215, Max-Change: 0.00313Iteration: 46, Log-Lik: -49934.142, Max-Change: 0.00330Iteration: 47, Log-Lik: -49934.090, Max-Change: 0.00304Iteration: 48, Log-Lik: -49934.041, Max-Change: 0.00236Iteration: 49, Log-Lik: -49933.993, Max-Change: 0.00308Iteration: 50, Log-Lik: -49933.945, Max-Change: 0.00581Iteration: 51, Log-Lik: -49933.895, Max-Change: 0.00193Iteration: 52, Log-Lik: -49933.881, Max-Change: 0.00328Iteration: 53, Log-Lik: -49933.842, Max-Change: 0.00280Iteration: 54, Log-Lik: -49933.807, Max-Change: 0.00251Iteration: 55, Log-Lik: -49933.676, Max-Change: 0.00392Iteration: 56, Log-Lik: -49933.637, Max-Change: 0.00143Iteration: 57, Log-Lik: -49933.620, Max-Change: 0.00326Iteration: 58, Log-Lik: -49933.596, Max-Change: 0.00268Iteration: 59, Log-Lik: -49933.571, Max-Change: 0.00170Iteration: 60, Log-Lik: -49933.556, Max-Change: 0.00119Iteration: 61, Log-Lik: -49933.528, Max-Change: 0.00203Iteration: 62, Log-Lik: -49933.512, Max-Change: 0.00122Iteration: 63, Log-Lik: -49933.498, Max-Change: 0.00216Iteration: 64, Log-Lik: -49933.463, Max-Change: 0.00149Iteration: 65, Log-Lik: -49933.449, Max-Change: 0.00201Iteration: 66, Log-Lik: -49933.431, Max-Change: 0.00196Iteration: 67, Log-Lik: -49933.397, Max-Change: 0.00226Iteration: 68, Log-Lik: -49933.379, Max-Change: 0.00139Iteration: 69, Log-Lik: -49933.369, Max-Change: 0.00166Iteration: 70, Log-Lik: -49933.344, Max-Change: 0.00289Iteration: 71, Log-Lik: -49933.323, Max-Change: 0.00126Iteration: 72, Log-Lik: -49933.313, Max-Change: 0.00119Iteration: 73, Log-Lik: -49933.300, Max-Change: 0.00440Iteration: 74, Log-Lik: -49933.282, Max-Change: 0.00116Iteration: 75, Log-Lik: -49933.271, Max-Change: 0.00154Iteration: 76, Log-Lik: -49933.253, Max-Change: 0.00227Iteration: 77, Log-Lik: -49933.243, Max-Change: 0.00135Iteration: 78, Log-Lik: -49933.236, Max-Change: 0.00194Iteration: 79, Log-Lik: -49933.226, Max-Change: 0.00192Iteration: 80, Log-Lik: -49933.215, Max-Change: 0.00136Iteration: 81, Log-Lik: -49933.210, Max-Change: 0.00143Iteration: 82, Log-Lik: -49933.202, Max-Change: 0.00135Iteration: 83, Log-Lik: -49933.195, Max-Change: 0.00240Iteration: 84, Log-Lik: -49933.185, Max-Change: 0.00116Iteration: 85, Log-Lik: -49933.177, Max-Change: 0.00080Iteration: 86, Log-Lik: -49933.173, Max-Change: 0.00071Iteration: 87, Log-Lik: -49933.170, Max-Change: 0.00068Iteration: 88, Log-Lik: -49933.157, Max-Change: 0.00423Iteration: 89, Log-Lik: -49933.143, Max-Change: 0.00074Iteration: 90, Log-Lik: -49933.139, Max-Change: 0.00088Iteration: 91, Log-Lik: -49933.138, Max-Change: 0.00164Iteration: 92, Log-Lik: -49933.129, Max-Change: 0.00082Iteration: 93, Log-Lik: -49933.124, Max-Change: 0.00106Iteration: 94, Log-Lik: -49933.112, Max-Change: 0.00100Iteration: 95, Log-Lik: -49933.109, Max-Change: 0.00091Iteration: 96, Log-Lik: -49933.105, Max-Change: 0.00169Iteration: 97, Log-Lik: -49933.104, Max-Change: 0.00202Iteration: 98, Log-Lik: -49933.099, Max-Change: 0.00092Iteration: 99, Log-Lik: -49933.099, Max-Change: 0.00065Iteration: 100, Log-Lik: -49933.098, Max-Change: 0.00077Iteration: 101, Log-Lik: -49933.096, Max-Change: 0.00036Iteration: 102, Log-Lik: -49933.095, Max-Change: 0.00032Iteration: 103, Log-Lik: -49933.095, Max-Change: 0.00065Iteration: 104, Log-Lik: -49933.094, Max-Change: 0.00093Iteration: 105, Log-Lik: -49933.093, Max-Change: 0.00066Iteration: 106, Log-Lik: -49933.093, Max-Change: 0.00082Iteration: 107, Log-Lik: -49933.090, Max-Change: 0.00031Iteration: 108, Log-Lik: -49933.090, Max-Change: 0.00028Iteration: 109, Log-Lik: -49933.090, Max-Change: 0.00066Iteration: 110, Log-Lik: -49933.089, Max-Change: 0.00097Iteration: 111, Log-Lik: -49933.088, Max-Change: 0.00069Iteration: 112, Log-Lik: -49933.088, Max-Change: 0.00087Iteration: 113, Log-Lik: -49933.085, Max-Change: 0.00051Iteration: 114, Log-Lik: -49933.084, Max-Change: 0.00076Iteration: 115, Log-Lik: -49933.083, Max-Change: 0.00083Iteration: 116, Log-Lik: -49933.083, Max-Change: 0.00106Iteration: 117, Log-Lik: -49933.082, Max-Change: 0.00097Iteration: 118, Log-Lik: -49933.081, Max-Change: 0.00080Iteration: 119, Log-Lik: -49933.081, Max-Change: 0.00100Iteration: 120, Log-Lik: -49933.080, Max-Change: 0.00081Iteration: 121, Log-Lik: -49933.080, Max-Change: 0.00072Iteration: 122, Log-Lik: -49933.079, Max-Change: 0.00089Iteration: 123, Log-Lik: -49933.078, Max-Change: 0.00073Iteration: 124, Log-Lik: -49933.078, Max-Change: 0.00059Iteration: 125, Log-Lik: -49933.077, Max-Change: 0.00069Iteration: 126, Log-Lik: -49933.077, Max-Change: 0.00057Iteration: 127, Log-Lik: -49933.076, Max-Change: 0.00070Iteration: 128, Log-Lik: -49933.075, Max-Change: 0.00051Iteration: 129, Log-Lik: -49933.074, Max-Change: 0.00035Iteration: 130, Log-Lik: -49933.074, Max-Change: 0.00075Iteration: 131, Log-Lik: -49933.072, Max-Change: 0.00044Iteration: 132, Log-Lik: -49933.072, Max-Change: 0.00030Iteration: 133, Log-Lik: -49933.072, Max-Change: 0.00045Iteration: 134, Log-Lik: -49933.071, Max-Change: 0.00049Iteration: 135, Log-Lik: -49933.071, Max-Change: 0.00041Iteration: 136, Log-Lik: -49933.070, Max-Change: 0.00064Iteration: 137, Log-Lik: -49933.069, Max-Change: 0.00030Iteration: 138, Log-Lik: -49933.069, Max-Change: 0.00030Iteration: 139, Log-Lik: -49933.068, Max-Change: 0.00041Iteration: 140, Log-Lik: -49933.068, Max-Change: 0.00050Iteration: 141, Log-Lik: -49933.067, Max-Change: 0.00039Iteration: 142, Log-Lik: -49933.067, Max-Change: 0.00073Iteration: 143, Log-Lik: -49933.065, Max-Change: 0.00056Iteration: 144, Log-Lik: -49933.065, Max-Change: 0.00044Iteration: 145, Log-Lik: -49933.065, Max-Change: 0.00041Iteration: 146, Log-Lik: -49933.064, Max-Change: 0.00046Iteration: 147, Log-Lik: -49933.064, Max-Change: 0.00045Iteration: 148, Log-Lik: -49933.064, Max-Change: 0.00044Iteration: 149, Log-Lik: -49933.063, Max-Change: 0.00067Iteration: 150, Log-Lik: -49933.063, Max-Change: 0.00054Iteration: 151, Log-Lik: -49933.063, Max-Change: 0.00039Iteration: 152, Log-Lik: -49933.062, Max-Change: 0.00026Iteration: 153, Log-Lik: -49933.061, Max-Change: 0.00027Iteration: 154, Log-Lik: -49933.061, Max-Change: 0.00077Iteration: 155, Log-Lik: -49933.061, Max-Change: 0.00133Iteration: 156, Log-Lik: -49933.061, Max-Change: 0.00112Iteration: 157, Log-Lik: -49933.060, Max-Change: 0.00048Iteration: 158, Log-Lik: -49933.059, Max-Change: 0.00077Iteration: 159, Log-Lik: -49933.059, Max-Change: 0.00063Iteration: 160, Log-Lik: -49933.059, Max-Change: 0.00038Iteration: 161, Log-Lik: -49933.058, Max-Change: 0.00037Iteration: 162, Log-Lik: -49933.057, Max-Change: 0.00049Iteration: 163, Log-Lik: -49933.057, Max-Change: 0.00089Iteration: 164, Log-Lik: -49933.057, Max-Change: 0.00129Iteration: 165, Log-Lik: -49933.057, Max-Change: 0.00116Iteration: 166, Log-Lik: -49933.056, Max-Change: 0.00060Iteration: 167, Log-Lik: -49933.056, Max-Change: 0.00080Iteration: 168, Log-Lik: -49933.056, Max-Change: 0.00073Iteration: 169, Log-Lik: -49933.055, Max-Change: 0.00036Iteration: 170, Log-Lik: -49933.055, Max-Change: 0.00071Iteration: 171, Log-Lik: -49933.054, Max-Change: 0.00123Iteration: 172, Log-Lik: -49933.054, Max-Change: 0.00035Iteration: 173, Log-Lik: -49933.053, Max-Change: 0.00014Iteration: 174, Log-Lik: -49933.053, Max-Change: 0.00072Iteration: 175, Log-Lik: -49933.053, Max-Change: 0.00118Iteration: 176, Log-Lik: -49933.052, Max-Change: 0.00107Iteration: 177, Log-Lik: -49933.052, Max-Change: 0.00089Iteration: 178, Log-Lik: -49933.052, Max-Change: 0.00042Iteration: 179, Log-Lik: -49933.051, Max-Change: 0.00066Iteration: 180, Log-Lik: -49933.051, Max-Change: 0.00054Iteration: 181, Log-Lik: -49933.051, Max-Change: 0.00034Iteration: 182, Log-Lik: -49933.050, Max-Change: 0.00056Iteration: 183, Log-Lik: -49933.050, Max-Change: 0.00093Iteration: 184, Log-Lik: -49933.049, Max-Change: 0.00033Iteration: 185, Log-Lik: -49933.049, Max-Change: 0.00022Iteration: 186, Log-Lik: -49933.049, Max-Change: 0.00020Iteration: 187, Log-Lik: -49933.049, Max-Change: 0.00056Iteration: 188, Log-Lik: -49933.048, Max-Change: 0.00099Iteration: 189, Log-Lik: -49933.048, Max-Change: 0.00081Iteration: 190, Log-Lik: -49933.048, Max-Change: 0.00039Iteration: 191, Log-Lik: -49933.047, Max-Change: 0.00071Iteration: 192, Log-Lik: -49933.047, Max-Change: 0.00058Iteration: 193, Log-Lik: -49933.047, Max-Change: 0.00032Iteration: 194, Log-Lik: -49933.046, Max-Change: 0.00028Iteration: 195, Log-Lik: -49933.046, Max-Change: 0.00022Iteration: 196, Log-Lik: -49933.046, Max-Change: 0.00050Iteration: 197, Log-Lik: -49933.046, Max-Change: 0.00074Iteration: 198, Log-Lik: -49933.046, Max-Change: 0.00063Iteration: 199, Log-Lik: -49933.046, Max-Change: 0.00031Iteration: 200, Log-Lik: -49933.045, Max-Change: 0.00036Iteration: 201, Log-Lik: -49933.045, Max-Change: 0.00032Iteration: 202, Log-Lik: -49933.045, Max-Change: 0.00031Iteration: 203, Log-Lik: -49933.044, Max-Change: 0.00040Iteration: 204, Log-Lik: -49933.044, Max-Change: 0.00032Iteration: 205, Log-Lik: -49933.044, Max-Change: 0.00030Iteration: 206, Log-Lik: -49933.044, Max-Change: 0.00033Iteration: 207, Log-Lik: -49933.044, Max-Change: 0.00029Iteration: 208, Log-Lik: -49933.043, Max-Change: 0.00030Iteration: 209, Log-Lik: -49933.043, Max-Change: 0.00047Iteration: 210, Log-Lik: -49933.043, Max-Change: 0.00038Iteration: 211, Log-Lik: -49933.043, Max-Change: 0.00030Iteration: 212, Log-Lik: -49933.042, Max-Change: 0.00053Iteration: 213, Log-Lik: -49933.042, Max-Change: 0.00094Iteration: 214, Log-Lik: -49933.042, Max-Change: 0.00029Iteration: 215, Log-Lik: -49933.041, Max-Change: 0.00027Iteration: 216, Log-Lik: -49933.041, Max-Change: 0.00024Iteration: 217, Log-Lik: -49933.041, Max-Change: 0.00032Iteration: 218, Log-Lik: -49933.041, Max-Change: 0.00059Iteration: 219, Log-Lik: -49933.041, Max-Change: 0.00047Iteration: 220, Log-Lik: -49933.041, Max-Change: 0.00028Iteration: 221, Log-Lik: -49933.040, Max-Change: 0.00016Iteration: 222, Log-Lik: -49933.040, Max-Change: 0.00061Iteration: 223, Log-Lik: -49933.040, Max-Change: 0.00120Iteration: 224, Log-Lik: -49933.040, Max-Change: 0.00099Iteration: 225, Log-Lik: -49933.040, Max-Change: 0.00083Iteration: 226, Log-Lik: -49933.039, Max-Change: 0.00055Iteration: 227, Log-Lik: -49933.039, Max-Change: 0.00083Iteration: 228, Log-Lik: -49933.039, Max-Change: 0.00070Iteration: 229, Log-Lik: -49933.039, Max-Change: 0.00041Iteration: 230, Log-Lik: -49933.039, Max-Change: 0.00060Iteration: 231, Log-Lik: -49933.038, Max-Change: 0.00052Iteration: 232, Log-Lik: -49933.038, Max-Change: 0.00027Iteration: 233, Log-Lik: -49933.038, Max-Change: 0.00025Iteration: 234, Log-Lik: -49933.038, Max-Change: 0.00022Iteration: 235, Log-Lik: -49933.038, Max-Change: 0.00031Iteration: 236, Log-Lik: -49933.038, Max-Change: 0.00057Iteration: 237, Log-Lik: -49933.037, Max-Change: 0.00046Iteration: 238, Log-Lik: -49933.037, Max-Change: 0.00026Iteration: 239, Log-Lik: -49933.037, Max-Change: 0.00019Iteration: 240, Log-Lik: -49933.037, Max-Change: 0.00015Iteration: 241, Log-Lik: -49933.037, Max-Change: 0.00050Iteration: 242, Log-Lik: -49933.037, Max-Change: 0.00076Iteration: 243, Log-Lik: -49933.037, Max-Change: 0.00065Iteration: 244, Log-Lik: -49933.036, Max-Change: 0.00037Iteration: 245, Log-Lik: -49933.036, Max-Change: 0.00055Iteration: 246, Log-Lik: -49933.036, Max-Change: 0.00047Iteration: 247, Log-Lik: -49933.036, Max-Change: 0.00025Iteration: 248, Log-Lik: -49933.036, Max-Change: 0.00019Iteration: 249, Log-Lik: -49933.036, Max-Change: 0.00017Iteration: 250, Log-Lik: -49933.035, Max-Change: 0.00037Iteration: 251, Log-Lik: -49933.035, Max-Change: 0.00066Iteration: 252, Log-Lik: -49933.035, Max-Change: 0.00054Iteration: 253, Log-Lik: -49933.035, Max-Change: 0.00024Iteration: 254, Log-Lik: -49933.035, Max-Change: 0.00040Iteration: 255, Log-Lik: -49933.035, Max-Change: 0.00032Iteration: 256, Log-Lik: -49933.035, Max-Change: 0.00024Iteration: 257, Log-Lik: -49933.034, Max-Change: 0.00037Iteration: 258, Log-Lik: -49933.034, Max-Change: 0.00065Iteration: 259, Log-Lik: -49933.034, Max-Change: 0.00037Iteration: 260, Log-Lik: -49933.034, Max-Change: 0.00055Iteration: 261, Log-Lik: -49933.034, Max-Change: 0.00047Iteration: 262, Log-Lik: -49933.034, Max-Change: 0.00023Iteration: 263, Log-Lik: -49933.033, Max-Change: 0.00025Iteration: 264, Log-Lik: -49933.033, Max-Change: 0.00022Iteration: 265, Log-Lik: -49933.033, Max-Change: 0.00023Iteration: 266, Log-Lik: -49933.033, Max-Change: 0.00037Iteration: 267, Log-Lik: -49933.033, Max-Change: 0.00030Iteration: 268, Log-Lik: -49933.033, Max-Change: 0.00022Iteration: 269, Log-Lik: -49933.033, Max-Change: 0.00040Iteration: 270, Log-Lik: -49933.032, Max-Change: 0.00071Iteration: 271, Log-Lik: -49933.032, Max-Change: 0.00024Iteration: 272, Log-Lik: -49933.032, Max-Change: 0.00035Iteration: 273, Log-Lik: -49933.032, Max-Change: 0.00030Iteration: 274, Log-Lik: -49933.032, Max-Change: 0.00021Iteration: 275, Log-Lik: -49933.032, Max-Change: 0.00042Iteration: 276, Log-Lik: -49933.032, Max-Change: 0.00063Iteration: 277, Log-Lik: -49933.031, Max-Change: 0.00021Iteration: 278, Log-Lik: -49933.031, Max-Change: 0.00040Iteration: 279, Log-Lik: -49933.031, Max-Change: 0.00032Iteration: 280, Log-Lik: -49933.031, Max-Change: 0.00021Iteration: 281, Log-Lik: -49933.031, Max-Change: 0.00023Iteration: 282, Log-Lik: -49933.031, Max-Change: 0.00032Iteration: 283, Log-Lik: -49933.031, Max-Change: 0.00043Iteration: 284, Log-Lik: -49933.031, Max-Change: 0.00075Iteration: 285, Log-Lik: -49933.030, Max-Change: 0.00061Iteration: 286, Log-Lik: -49933.030, Max-Change: 0.00036Iteration: 287, Log-Lik: -49933.030, Max-Change: 0.00063Iteration: 288, Log-Lik: -49933.030, Max-Change: 0.00052Iteration: 289, Log-Lik: -49933.030, Max-Change: 0.00026Iteration: 290, Log-Lik: -49933.030, Max-Change: 0.00047Iteration: 291, Log-Lik: -49933.030, Max-Change: 0.00038Iteration: 292, Log-Lik: -49933.030, Max-Change: 0.00019Iteration: 293, Log-Lik: -49933.030, Max-Change: 0.00021Iteration: 294, Log-Lik: -49933.030, Max-Change: 0.00016Iteration: 295, Log-Lik: -49933.029, Max-Change: 0.00025Iteration: 296, Log-Lik: -49933.029, Max-Change: 0.00036Iteration: 297, Log-Lik: -49933.029, Max-Change: 0.00031Iteration: 298, Log-Lik: -49933.029, Max-Change: 0.00019Iteration: 299, Log-Lik: -49933.029, Max-Change: 0.00021Iteration: 300, Log-Lik: -49933.029, Max-Change: 0.00038Iteration: 301, Log-Lik: -49933.029, Max-Change: 0.00041Iteration: 302, Log-Lik: -49933.029, Max-Change: 0.00063Iteration: 303, Log-Lik: -49933.029, Max-Change: 0.00053Iteration: 304, Log-Lik: -49933.029, Max-Change: 0.00033Iteration: 305, Log-Lik: -49933.028, Max-Change: 0.00050Iteration: 306, Log-Lik: -49933.028, Max-Change: 0.00043Iteration: 307, Log-Lik: -49933.028, Max-Change: 0.00022Iteration: 308, Log-Lik: -49933.028, Max-Change: 0.00032Iteration: 309, Log-Lik: -49933.028, Max-Change: 0.00028Iteration: 310, Log-Lik: -49933.028, Max-Change: 0.00088Iteration: 311, Log-Lik: -49933.027, Max-Change: 0.00017Iteration: 312, Log-Lik: -49933.027, Max-Change: 0.00025Iteration: 313, Log-Lik: -49933.027, Max-Change: 0.00040Iteration: 314, Log-Lik: -49933.027, Max-Change: 0.00061Iteration: 315, Log-Lik: -49933.027, Max-Change: 0.00051Iteration: 316, Log-Lik: -49933.027, Max-Change: 0.00034Iteration: 317, Log-Lik: -49933.027, Max-Change: 0.00052Iteration: 318, Log-Lik: -49933.027, Max-Change: 0.00044Iteration: 319, Log-Lik: -49933.027, Max-Change: 0.00026Iteration: 320, Log-Lik: -49933.027, Max-Change: 0.00039Iteration: 321, Log-Lik: -49933.027, Max-Change: 0.00034Iteration: 322, Log-Lik: -49933.027, Max-Change: 0.00016Iteration: 323, Log-Lik: -49933.026, Max-Change: 0.00020Iteration: 324, Log-Lik: -49933.026, Max-Change: 0.00017Iteration: 325, Log-Lik: -49933.026, Max-Change: 0.00016Iteration: 326, Log-Lik: -49933.026, Max-Change: 0.00019Iteration: 327, Log-Lik: -49933.026, Max-Change: 0.00015Iteration: 328, Log-Lik: -49933.026, Max-Change: 0.00016Iteration: 329, Log-Lik: -49933.026, Max-Change: 0.00022Iteration: 330, Log-Lik: -49933.026, Max-Change: 0.00019Iteration: 331, Log-Lik: -49933.026, Max-Change: 0.00015Iteration: 332, Log-Lik: -49933.026, Max-Change: 0.00013Iteration: 333, Log-Lik: -49933.026, Max-Change: 0.00010Iteration: 334, Log-Lik: -49933.026, Max-Change: 0.00026Iteration: 335, Log-Lik: -49933.026, Max-Change: 0.00038Iteration: 336, Log-Lik: -49933.026, Max-Change: 0.00033Iteration: 337, Log-Lik: -49933.026, Max-Change: 0.00015Iteration: 338, Log-Lik: -49933.026, Max-Change: 0.00021Iteration: 339, Log-Lik: -49933.026, Max-Change: 0.00019Iteration: 340, Log-Lik: -49933.026, Max-Change: 0.00015Iteration: 341, Log-Lik: -49933.025, Max-Change: 0.00011Iteration: 342, Log-Lik: -49933.025, Max-Change: 0.00008
irt_mh_all
## 
## Call:
## mirt(data = mh_vars_num, model = 1, itemtype = mh_vars_options$itemtype)
## 
## Full-information item factor analysis with 1 factor(s).
## Converged within 1e-04 tolerance after 342 EM iterations.
## mirt version: 1.44.0 
## M-step optimizer: BFGS 
## EM acceleration: Ramsay 
## Number of rectangular quadrature: 61
## Latent density type: Gaussian 
## 
## Log-likelihood = -49933
## Estimated parameters: 276 
## AIC = 1e+05
## BIC = 101766; SABIC = 100890
irt_mh_all %>% summary()
##                                                                                                          F1
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               0.809
## Most_of_the_time_I_feel_blue                                                                          0.884
## I_often_feel_as_if_things_were_not_real                                                               0.683
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                      0.819
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                             0.832
## I_feel_that_I_have_often_been_punished_without_cause                                                  0.761
## Life_is_a_strain_for_me_much_of_the_time                                                              0.864
## I_have_strange_and_peculiar_thoughts                                                                  0.625
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up               0.817
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything             0.747
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to     0.712
## At_times_I_think_I_am_no_good_at_all                                                                  0.810
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                        0.693
## I_am_happy_most_of_the_time                                                                           0.787
## I_very_seldom_have_spells_of_the_blues                                                                0.658
## During_the_past_few_years_I_have_been_well_most_of_the_time                                           0.671
## My_daily_life_is_full_of_things_that_keep_me_interested                                               0.746
## I_am_usually_calm_and_not_easily_upset                                                                0.663
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                              0.667
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                      0.632
## I_am_liked_by_most_people_who_know_me                                                                 0.596
## I_am_not_easily_angered                                                                               0.545
## I_do_not_mind_meeting_strangers                                                                       0.453
## I_get_all_the_sympathy_I_should                                                                       0.579
## Little_interest_or_pleasure_in_doing_things                                                           0.826
## Feeling_down_depressed_or_hopeless                                                                    0.902
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                    0.802
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                               0.484
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                          0.491
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 0.839
## Feeling_panic_or_being_frightened                                                                     0.853
## Avoiding_situations_that_make_you_anxious                                                             0.723
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                         0.656
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                      0.768
## Thoughts_of_actually_hurting_yourself                                                                 0.797
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                  0.537
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking 0.528
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                         0.700
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home          0.722
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                   0.800
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                        0.708
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories       0.795
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                           0.826
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                            0.858
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                     0.291
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                              0.302
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                      0.476
## Life_satisfaction                                                                                     0.799
## Job_satisfaction                                                                                      0.602
## Social_satisfaction                                                                                   0.711
## Romantic_satisfaction                                                                                 0.533
## Mood_higher_means_better_mood                                                                         0.816
## Anxiety_levels_higher_means_less_anxious                                                              0.447
## In_most_ways_my_life_is_close_to_my_ideal                                                             0.718
## The_conditions_of_my_life_are_excellent                                                               0.708
## I_am_satisfied_with_my_life                                                                           0.770
## So_far_I_have_gotten_the_important_things_I_want_in_life                                              0.692
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                            0.566
## Attention_deficit_hyperactivity_disorder_ADHD                                                         0.377
## Alcohol_abuse                                                                                         0.347
## Non_alcohol_drug_abuse                                                                                0.468
## Autism_spectrum_disorder_ASD                                                                          0.468
## Anti_social_personality_disorder                                                                      0.741
## Bipolarity                                                                                            0.447
## Borderline_Personality_Disorder                                                                       0.703
## Depression                                                                                            0.617
## General_Anxiety_Disorder_GAD                                                                          0.518
## Obsessive_compulsive_disorder_OCD                                                                     0.368
## Panic_disorder                                                                                        0.524
## Paranoia_Paranoid_personality_disorder                                                                0.535
## Phobias_social                                                                                        0.596
## Specific_phobias                                                                                      0.558
## Post_traumatic_stress_disorder_PTSD                                                                   0.612
## Schizophrenia                                                                                         0.481
## Schizoid_personality_disorder                                                                         0.564
## Sleeping_disorders                                                                                    0.493
##                                                                                                           h2
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               0.6540
## Most_of_the_time_I_feel_blue                                                                          0.7809
## I_often_feel_as_if_things_were_not_real                                                               0.4664
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                      0.6712
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                             0.6925
## I_feel_that_I_have_often_been_punished_without_cause                                                  0.5786
## Life_is_a_strain_for_me_much_of_the_time                                                              0.7463
## I_have_strange_and_peculiar_thoughts                                                                  0.3910
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up               0.6667
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything             0.5581
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to     0.5065
## At_times_I_think_I_am_no_good_at_all                                                                  0.6558
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                        0.4805
## I_am_happy_most_of_the_time                                                                           0.6188
## I_very_seldom_have_spells_of_the_blues                                                                0.4325
## During_the_past_few_years_I_have_been_well_most_of_the_time                                           0.4498
## My_daily_life_is_full_of_things_that_keep_me_interested                                               0.5562
## I_am_usually_calm_and_not_easily_upset                                                                0.4391
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                              0.4452
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                      0.3997
## I_am_liked_by_most_people_who_know_me                                                                 0.3550
## I_am_not_easily_angered                                                                               0.2975
## I_do_not_mind_meeting_strangers                                                                       0.2051
## I_get_all_the_sympathy_I_should                                                                       0.3357
## Little_interest_or_pleasure_in_doing_things                                                           0.6824
## Feeling_down_depressed_or_hopeless                                                                    0.8128
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                    0.6432
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                               0.2341
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                          0.2415
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 0.7045
## Feeling_panic_or_being_frightened                                                                     0.7277
## Avoiding_situations_that_make_you_anxious                                                             0.5220
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                         0.4302
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                      0.5897
## Thoughts_of_actually_hurting_yourself                                                                 0.6356
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                  0.2886
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking 0.2789
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                         0.4898
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home          0.5213
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                   0.6407
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                        0.5010
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories       0.6325
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                           0.6820
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                            0.7368
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                     0.0846
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                              0.0911
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                      0.2267
## Life_satisfaction                                                                                     0.6377
## Job_satisfaction                                                                                      0.3621
## Social_satisfaction                                                                                   0.5050
## Romantic_satisfaction                                                                                 0.2840
## Mood_higher_means_better_mood                                                                         0.6658
## Anxiety_levels_higher_means_less_anxious                                                              0.1998
## In_most_ways_my_life_is_close_to_my_ideal                                                             0.5158
## The_conditions_of_my_life_are_excellent                                                               0.5019
## I_am_satisfied_with_my_life                                                                           0.5927
## So_far_I_have_gotten_the_important_things_I_want_in_life                                              0.4793
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                            0.3208
## Attention_deficit_hyperactivity_disorder_ADHD                                                         0.1424
## Alcohol_abuse                                                                                         0.1205
## Non_alcohol_drug_abuse                                                                                0.2187
## Autism_spectrum_disorder_ASD                                                                          0.2188
## Anti_social_personality_disorder                                                                      0.5488
## Bipolarity                                                                                            0.1995
## Borderline_Personality_Disorder                                                                       0.4936
## Depression                                                                                            0.3807
## General_Anxiety_Disorder_GAD                                                                          0.2687
## Obsessive_compulsive_disorder_OCD                                                                     0.1353
## Panic_disorder                                                                                        0.2745
## Paranoia_Paranoid_personality_disorder                                                                0.2867
## Phobias_social                                                                                        0.3550
## Specific_phobias                                                                                      0.3116
## Post_traumatic_stress_disorder_PTSD                                                                   0.3740
## Schizophrenia                                                                                         0.2313
## Schizoid_personality_disorder                                                                         0.3185
## Sleeping_disorders                                                                                    0.2427
## 
## SS loadings:  34 
## Proportion Var:  0.447 
## 
## Factor correlations: 
## 
##    F1
## F1  1
#plot scale function
plot(
  irt_mh_all,
  type = "score"
)

#scores
irt_mh_all_scores = fscores(irt_mh_all, full.scores = T, full.scores.SE = T)
d$p_all = irt_mh_all_scores[, 1] %>% standardize()

#reliability
empirical_rxx(irt_mh_all_scores)
##    F1 
## 0.967
marginal_rxx(irt_mh_all)
## [1] 0.966
get_reliabilities(irt_mh_all) %>% 
  ggplot(aes(z, rel)) +
  geom_line()

#plot
d %>% 
  GG_denhist("p_all")
## `stat_bin()` using `bins = 30`. Pick better value with `binwidth`.

Non-diagnoses only

#which are the symptom scales
mh_vars_symptoms = mh_vars_num %>% select(-c(Attention_deficit_hyperactivity_disorder_ADHD:Sleeping_disorders)) %>% names()
mh_vars_symptoms_idx = which(names(mh_vars_num) %in% mh_vars_symptoms)

#fit a model with all symptom scales without diagnoses
irt_mh_symptoms = mirt(
  mh_vars_num %>% select(all_of(mh_vars_symptoms)),
  itemtype = mh_vars_options %>% slice(mh_vars_symptoms_idx) %>% pull(itemtype),
  model = 1
)
## Iteration: 1, Log-Lik: -48832.404, Max-Change: 3.07769Iteration: 2, Log-Lik: -47642.357, Max-Change: 1.08837Iteration: 3, Log-Lik: -47260.943, Max-Change: 0.40166Iteration: 4, Log-Lik: -47188.329, Max-Change: 0.16129Iteration: 5, Log-Lik: -47158.876, Max-Change: 0.09779Iteration: 6, Log-Lik: -47135.260, Max-Change: 0.07077Iteration: 7, Log-Lik: -47117.641, Max-Change: 0.08042Iteration: 8, Log-Lik: -47103.519, Max-Change: 0.04740Iteration: 9, Log-Lik: -47092.200, Max-Change: 0.05821Iteration: 10, Log-Lik: -47083.266, Max-Change: 0.07013Iteration: 11, Log-Lik: -47075.315, Max-Change: 0.04085Iteration: 12, Log-Lik: -47069.516, Max-Change: 0.03815Iteration: 13, Log-Lik: -47064.360, Max-Change: 0.05599Iteration: 14, Log-Lik: -47059.870, Max-Change: 0.04204Iteration: 15, Log-Lik: -47056.024, Max-Change: 0.03242Iteration: 16, Log-Lik: -47052.661, Max-Change: 0.03880Iteration: 17, Log-Lik: -47049.878, Max-Change: 0.03659Iteration: 18, Log-Lik: -47047.832, Max-Change: 0.02760Iteration: 19, Log-Lik: -47045.722, Max-Change: 0.02067Iteration: 20, Log-Lik: -47044.351, Max-Change: 0.02672Iteration: 21, Log-Lik: -47042.984, Max-Change: 0.02494Iteration: 22, Log-Lik: -47041.016, Max-Change: 0.02126Iteration: 23, Log-Lik: -47039.844, Max-Change: 0.03024Iteration: 24, Log-Lik: -47039.182, Max-Change: 0.01555Iteration: 25, Log-Lik: -47038.667, Max-Change: 0.01421Iteration: 26, Log-Lik: -47037.999, Max-Change: 0.01543Iteration: 27, Log-Lik: -47037.401, Max-Change: 0.01714Iteration: 28, Log-Lik: -47036.583, Max-Change: 0.01436Iteration: 29, Log-Lik: -47036.174, Max-Change: 0.01168Iteration: 30, Log-Lik: -47035.818, Max-Change: 0.01315Iteration: 31, Log-Lik: -47035.172, Max-Change: 0.01458Iteration: 32, Log-Lik: -47034.921, Max-Change: 0.00803Iteration: 33, Log-Lik: -47034.761, Max-Change: 0.00806Iteration: 34, Log-Lik: -47034.441, Max-Change: 0.00778Iteration: 35, Log-Lik: -47034.259, Max-Change: 0.01111Iteration: 36, Log-Lik: -47034.102, Max-Change: 0.01183Iteration: 37, Log-Lik: -47033.918, Max-Change: 0.00585Iteration: 38, Log-Lik: -47033.787, Max-Change: 0.00568Iteration: 39, Log-Lik: -47033.670, Max-Change: 0.00565Iteration: 40, Log-Lik: -47033.127, Max-Change: 0.00652Iteration: 41, Log-Lik: -47033.028, Max-Change: 0.00341Iteration: 42, Log-Lik: -47032.969, Max-Change: 0.00315Iteration: 43, Log-Lik: -47032.752, Max-Change: 0.00285Iteration: 44, Log-Lik: -47032.693, Max-Change: 0.00332Iteration: 45, Log-Lik: -47032.655, Max-Change: 0.00235Iteration: 46, Log-Lik: -47032.592, Max-Change: 0.00217Iteration: 47, Log-Lik: -47032.567, Max-Change: 0.00308Iteration: 48, Log-Lik: -47032.529, Max-Change: 0.00335Iteration: 49, Log-Lik: -47032.414, Max-Change: 0.00473Iteration: 50, Log-Lik: -47032.358, Max-Change: 0.00270Iteration: 51, Log-Lik: -47032.332, Max-Change: 0.00191Iteration: 52, Log-Lik: -47032.299, Max-Change: 0.00243Iteration: 53, Log-Lik: -47032.273, Max-Change: 0.00190Iteration: 54, Log-Lik: -47032.253, Max-Change: 0.00206Iteration: 55, Log-Lik: -47032.227, Max-Change: 0.00353Iteration: 56, Log-Lik: -47032.197, Max-Change: 0.00241Iteration: 57, Log-Lik: -47032.185, Max-Change: 0.00190Iteration: 58, Log-Lik: -47032.169, Max-Change: 0.00170Iteration: 59, Log-Lik: -47032.158, Max-Change: 0.00210Iteration: 60, Log-Lik: -47032.140, Max-Change: 0.00214Iteration: 61, Log-Lik: -47032.111, Max-Change: 0.00153Iteration: 62, Log-Lik: -47032.096, Max-Change: 0.00104Iteration: 63, Log-Lik: -47032.089, Max-Change: 0.00094Iteration: 64, Log-Lik: -47032.068, Max-Change: 0.00176Iteration: 65, Log-Lik: -47032.057, Max-Change: 0.00155Iteration: 66, Log-Lik: -47032.045, Max-Change: 0.00165Iteration: 67, Log-Lik: -47032.040, Max-Change: 0.00290Iteration: 68, Log-Lik: -47032.023, Max-Change: 0.00127Iteration: 69, Log-Lik: -47032.012, Max-Change: 0.00168Iteration: 70, Log-Lik: -47031.990, Max-Change: 0.00438Iteration: 71, Log-Lik: -47031.964, Max-Change: 0.00072Iteration: 72, Log-Lik: -47031.959, Max-Change: 0.00077Iteration: 73, Log-Lik: -47031.949, Max-Change: 0.00262Iteration: 74, Log-Lik: -47031.938, Max-Change: 0.00062Iteration: 75, Log-Lik: -47031.934, Max-Change: 0.00068Iteration: 76, Log-Lik: -47031.924, Max-Change: 0.00137Iteration: 77, Log-Lik: -47031.918, Max-Change: 0.00183Iteration: 78, Log-Lik: -47031.914, Max-Change: 0.00121Iteration: 79, Log-Lik: -47031.912, Max-Change: 0.00154Iteration: 80, Log-Lik: -47031.908, Max-Change: 0.00140Iteration: 81, Log-Lik: -47031.905, Max-Change: 0.00297Iteration: 82, Log-Lik: -47031.896, Max-Change: 0.00063Iteration: 83, Log-Lik: -47031.893, Max-Change: 0.00070Iteration: 84, Log-Lik: -47031.890, Max-Change: 0.00060Iteration: 85, Log-Lik: -47031.886, Max-Change: 0.00163Iteration: 86, Log-Lik: -47031.884, Max-Change: 0.00213Iteration: 87, Log-Lik: -47031.877, Max-Change: 0.00090Iteration: 88, Log-Lik: -47031.876, Max-Change: 0.00065Iteration: 89, Log-Lik: -47031.874, Max-Change: 0.00115Iteration: 90, Log-Lik: -47031.873, Max-Change: 0.00096Iteration: 91, Log-Lik: -47031.871, Max-Change: 0.00050Iteration: 92, Log-Lik: -47031.871, Max-Change: 0.00037Iteration: 93, Log-Lik: -47031.870, Max-Change: 0.00039Iteration: 94, Log-Lik: -47031.870, Max-Change: 0.00127Iteration: 95, Log-Lik: -47031.869, Max-Change: 0.00167Iteration: 96, Log-Lik: -47031.864, Max-Change: 0.00152Iteration: 97, Log-Lik: -47031.864, Max-Change: 0.00082Iteration: 98, Log-Lik: -47031.863, Max-Change: 0.00066Iteration: 99, Log-Lik: -47031.863, Max-Change: 0.00062Iteration: 100, Log-Lik: -47031.862, Max-Change: 0.00091Iteration: 101, Log-Lik: -47031.859, Max-Change: 0.00097Iteration: 102, Log-Lik: -47031.856, Max-Change: 0.00040Iteration: 103, Log-Lik: -47031.856, Max-Change: 0.00028Iteration: 104, Log-Lik: -47031.856, Max-Change: 0.00028Iteration: 105, Log-Lik: -47031.855, Max-Change: 0.00107Iteration: 106, Log-Lik: -47031.855, Max-Change: 0.00211Iteration: 107, Log-Lik: -47031.850, Max-Change: 0.00090Iteration: 108, Log-Lik: -47031.849, Max-Change: 0.00081Iteration: 109, Log-Lik: -47031.849, Max-Change: 0.00097Iteration: 110, Log-Lik: -47031.846, Max-Change: 0.00052Iteration: 111, Log-Lik: -47031.846, Max-Change: 0.00033Iteration: 112, Log-Lik: -47031.845, Max-Change: 0.00072Iteration: 113, Log-Lik: -47031.843, Max-Change: 0.00021Iteration: 114, Log-Lik: -47031.843, Max-Change: 0.00079Iteration: 115, Log-Lik: -47031.842, Max-Change: 0.00165Iteration: 116, Log-Lik: -47031.841, Max-Change: 0.00136Iteration: 117, Log-Lik: -47031.841, Max-Change: 0.00117Iteration: 118, Log-Lik: -47031.840, Max-Change: 0.00069Iteration: 119, Log-Lik: -47031.839, Max-Change: 0.00100Iteration: 120, Log-Lik: -47031.839, Max-Change: 0.00087Iteration: 121, Log-Lik: -47031.838, Max-Change: 0.00080Iteration: 122, Log-Lik: -47031.836, Max-Change: 0.00029Iteration: 123, Log-Lik: -47031.836, Max-Change: 0.00022Iteration: 124, Log-Lik: -47031.836, Max-Change: 0.00083Iteration: 125, Log-Lik: -47031.835, Max-Change: 0.00125Iteration: 126, Log-Lik: -47031.834, Max-Change: 0.00107Iteration: 127, Log-Lik: -47031.834, Max-Change: 0.00062Iteration: 128, Log-Lik: -47031.833, Max-Change: 0.00090Iteration: 129, Log-Lik: -47031.833, Max-Change: 0.00078Iteration: 130, Log-Lik: -47031.832, Max-Change: 0.00076Iteration: 131, Log-Lik: -47031.830, Max-Change: 0.00037Iteration: 132, Log-Lik: -47031.830, Max-Change: 0.00029Iteration: 133, Log-Lik: -47031.830, Max-Change: 0.00052Iteration: 134, Log-Lik: -47031.829, Max-Change: 0.00074Iteration: 135, Log-Lik: -47031.828, Max-Change: 0.00064Iteration: 136, Log-Lik: -47031.828, Max-Change: 0.00060Iteration: 137, Log-Lik: -47031.827, Max-Change: 0.00034Iteration: 138, Log-Lik: -47031.827, Max-Change: 0.00023Iteration: 139, Log-Lik: -47031.826, Max-Change: 0.00053Iteration: 140, Log-Lik: -47031.826, Max-Change: 0.00061Iteration: 141, Log-Lik: -47031.825, Max-Change: 0.00051Iteration: 142, Log-Lik: -47031.825, Max-Change: 0.00070Iteration: 143, Log-Lik: -47031.823, Max-Change: 0.00044Iteration: 144, Log-Lik: -47031.823, Max-Change: 0.00029Iteration: 145, Log-Lik: -47031.823, Max-Change: 0.00071Iteration: 146, Log-Lik: -47031.821, Max-Change: 0.00033Iteration: 147, Log-Lik: -47031.821, Max-Change: 0.00023Iteration: 148, Log-Lik: -47031.821, Max-Change: 0.00039Iteration: 149, Log-Lik: -47031.820, Max-Change: 0.00049Iteration: 150, Log-Lik: -47031.820, Max-Change: 0.00043Iteration: 151, Log-Lik: -47031.820, Max-Change: 0.00057Iteration: 152, Log-Lik: -47031.819, Max-Change: 0.00040Iteration: 153, Log-Lik: -47031.818, Max-Change: 0.00036Iteration: 154, Log-Lik: -47031.818, Max-Change: 0.00044Iteration: 155, Log-Lik: -47031.817, Max-Change: 0.00082Iteration: 156, Log-Lik: -47031.817, Max-Change: 0.00067Iteration: 157, Log-Lik: -47031.817, Max-Change: 0.00038Iteration: 158, Log-Lik: -47031.816, Max-Change: 0.00080Iteration: 159, Log-Lik: -47031.816, Max-Change: 0.00122Iteration: 160, Log-Lik: -47031.815, Max-Change: 0.00038Iteration: 161, Log-Lik: -47031.814, Max-Change: 0.00060Iteration: 162, Log-Lik: -47031.814, Max-Change: 0.00049Iteration: 163, Log-Lik: -47031.814, Max-Change: 0.00037Iteration: 164, Log-Lik: -47031.813, Max-Change: 0.00023Iteration: 165, Log-Lik: -47031.813, Max-Change: 0.00021Iteration: 166, Log-Lik: -47031.813, Max-Change: 0.00073Iteration: 167, Log-Lik: -47031.813, Max-Change: 0.00128Iteration: 168, Log-Lik: -47031.812, Max-Change: 0.00106Iteration: 169, Log-Lik: -47031.812, Max-Change: 0.00054Iteration: 170, Log-Lik: -47031.812, Max-Change: 0.00097Iteration: 171, Log-Lik: -47031.811, Max-Change: 0.00080Iteration: 172, Log-Lik: -47031.811, Max-Change: 0.00036Iteration: 173, Log-Lik: -47031.810, Max-Change: 0.00053Iteration: 174, Log-Lik: -47031.810, Max-Change: 0.00042Iteration: 175, Log-Lik: -47031.810, Max-Change: 0.00036Iteration: 176, Log-Lik: -47031.809, Max-Change: 0.00031Iteration: 177, Log-Lik: -47031.809, Max-Change: 0.00028Iteration: 178, Log-Lik: -47031.809, Max-Change: 0.00047Iteration: 179, Log-Lik: -47031.809, Max-Change: 0.00086Iteration: 180, Log-Lik: -47031.808, Max-Change: 0.00070Iteration: 181, Log-Lik: -47031.808, Max-Change: 0.00035Iteration: 182, Log-Lik: -47031.808, Max-Change: 0.00039Iteration: 183, Log-Lik: -47031.807, Max-Change: 0.00031Iteration: 184, Log-Lik: -47031.807, Max-Change: 0.00042Iteration: 185, Log-Lik: -47031.807, Max-Change: 0.00060Iteration: 186, Log-Lik: -47031.807, Max-Change: 0.00052Iteration: 187, Log-Lik: -47031.806, Max-Change: 0.00034Iteration: 188, Log-Lik: -47031.806, Max-Change: 0.00034Iteration: 189, Log-Lik: -47031.805, Max-Change: 0.00017Iteration: 190, Log-Lik: -47031.805, Max-Change: 0.00040Iteration: 191, Log-Lik: -47031.805, Max-Change: 0.00073Iteration: 192, Log-Lik: -47031.805, Max-Change: 0.00060Iteration: 193, Log-Lik: -47031.804, Max-Change: 0.00033Iteration: 194, Log-Lik: -47031.804, Max-Change: 0.00031Iteration: 195, Log-Lik: -47031.804, Max-Change: 0.00024Iteration: 196, Log-Lik: -47031.804, Max-Change: 0.00043Iteration: 197, Log-Lik: -47031.803, Max-Change: 0.00063Iteration: 198, Log-Lik: -47031.803, Max-Change: 0.00055Iteration: 199, Log-Lik: -47031.803, Max-Change: 0.00032Iteration: 200, Log-Lik: -47031.802, Max-Change: 0.00017Iteration: 201, Log-Lik: -47031.802, Max-Change: 0.00016Iteration: 202, Log-Lik: -47031.802, Max-Change: 0.00059Iteration: 203, Log-Lik: -47031.802, Max-Change: 0.00104Iteration: 204, Log-Lik: -47031.802, Max-Change: 0.00086Iteration: 205, Log-Lik: -47031.801, Max-Change: 0.00045Iteration: 206, Log-Lik: -47031.801, Max-Change: 0.00081Iteration: 207, Log-Lik: -47031.801, Max-Change: 0.00066Iteration: 208, Log-Lik: -47031.801, Max-Change: 0.00031Iteration: 209, Log-Lik: -47031.800, Max-Change: 0.00047Iteration: 210, Log-Lik: -47031.800, Max-Change: 0.00038Iteration: 211, Log-Lik: -47031.800, Max-Change: 0.00030Iteration: 212, Log-Lik: -47031.800, Max-Change: 0.00057Iteration: 213, Log-Lik: -47031.800, Max-Change: 0.00101Iteration: 214, Log-Lik: -47031.799, Max-Change: 0.00030Iteration: 215, Log-Lik: -47031.799, Max-Change: 0.00016Iteration: 216, Log-Lik: -47031.799, Max-Change: 0.00015Iteration: 217, Log-Lik: -47031.798, Max-Change: 0.00056Iteration: 218, Log-Lik: -47031.798, Max-Change: 0.00100Iteration: 219, Log-Lik: -47031.798, Max-Change: 0.00082Iteration: 220, Log-Lik: -47031.798, Max-Change: 0.00043Iteration: 221, Log-Lik: -47031.798, Max-Change: 0.00078Iteration: 222, Log-Lik: -47031.797, Max-Change: 0.00064Iteration: 223, Log-Lik: -47031.797, Max-Change: 0.00029Iteration: 224, Log-Lik: -47031.797, Max-Change: 0.00047Iteration: 225, Log-Lik: -47031.797, Max-Change: 0.00038Iteration: 226, Log-Lik: -47031.797, Max-Change: 0.00028Iteration: 227, Log-Lik: -47031.796, Max-Change: 0.00031Iteration: 228, Log-Lik: -47031.796, Max-Change: 0.00057Iteration: 229, Log-Lik: -47031.796, Max-Change: 0.00053Iteration: 230, Log-Lik: -47031.796, Max-Change: 0.00080Iteration: 231, Log-Lik: -47031.796, Max-Change: 0.00068Iteration: 232, Log-Lik: -47031.795, Max-Change: 0.00038Iteration: 233, Log-Lik: -47031.795, Max-Change: 0.00056Iteration: 234, Log-Lik: -47031.795, Max-Change: 0.00048Iteration: 235, Log-Lik: -47031.795, Max-Change: 0.00027Iteration: 236, Log-Lik: -47031.795, Max-Change: 0.00019Iteration: 237, Log-Lik: -47031.794, Max-Change: 0.00017Iteration: 238, Log-Lik: -47031.794, Max-Change: 0.00040Iteration: 239, Log-Lik: -47031.794, Max-Change: 0.00072Iteration: 240, Log-Lik: -47031.794, Max-Change: 0.00059Iteration: 241, Log-Lik: -47031.794, Max-Change: 0.00026Iteration: 242, Log-Lik: -47031.794, Max-Change: 0.00045Iteration: 243, Log-Lik: -47031.794, Max-Change: 0.00037Iteration: 244, Log-Lik: -47031.793, Max-Change: 0.00026Iteration: 245, Log-Lik: -47031.793, Max-Change: 0.00025Iteration: 246, Log-Lik: -47031.793, Max-Change: 0.00043Iteration: 247, Log-Lik: -47031.793, Max-Change: 0.00145Iteration: 248, Log-Lik: -47031.793, Max-Change: 0.00123Iteration: 249, Log-Lik: -47031.793, Max-Change: 0.00102Iteration: 250, Log-Lik: -47031.792, Max-Change: 0.00015Iteration: 251, Log-Lik: -47031.792, Max-Change: 0.00014Iteration: 252, Log-Lik: -47031.792, Max-Change: 0.00010Iteration: 253, Log-Lik: -47031.792, Max-Change: 0.00032Iteration: 254, Log-Lik: -47031.792, Max-Change: 0.00048Iteration: 255, Log-Lik: -47031.791, Max-Change: 0.00041Iteration: 256, Log-Lik: -47031.791, Max-Change: 0.00024Iteration: 257, Log-Lik: -47031.791, Max-Change: 0.00029Iteration: 258, Log-Lik: -47031.791, Max-Change: 0.00026Iteration: 259, Log-Lik: -47031.791, Max-Change: 0.00024Iteration: 260, Log-Lik: -47031.791, Max-Change: 0.00023Iteration: 261, Log-Lik: -47031.790, Max-Change: 0.00029Iteration: 262, Log-Lik: -47031.790, Max-Change: 0.00010
irt_mh_symptoms
## 
## Call:
## mirt(data = mh_vars_num %>% select(all_of(mh_vars_symptoms)), 
##     model = 1, itemtype = mh_vars_options %>% slice(mh_vars_symptoms_idx) %>% 
##         pull(itemtype))
## 
## Full-information item factor analysis with 1 factor(s).
## Converged within 1e-04 tolerance after 262 EM iterations.
## mirt version: 1.44.0 
## M-step optimizer: BFGS 
## EM acceleration: Ramsay 
## Number of rectangular quadrature: 61
## Latent density type: Gaussian 
## 
## Log-likelihood = -47032
## Estimated parameters: 240 
## AIC = 94544
## BIC = 95716; SABIC = 94954
irt_mh_symptoms %>% summary()
##                                                                                                          F1
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               0.811
## Most_of_the_time_I_feel_blue                                                                          0.885
## I_often_feel_as_if_things_were_not_real                                                               0.686
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                      0.818
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                             0.833
## I_feel_that_I_have_often_been_punished_without_cause                                                  0.762
## Life_is_a_strain_for_me_much_of_the_time                                                              0.865
## I_have_strange_and_peculiar_thoughts                                                                  0.623
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up               0.818
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything             0.747
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to     0.712
## At_times_I_think_I_am_no_good_at_all                                                                  0.808
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                        0.688
## I_am_happy_most_of_the_time                                                                           0.789
## I_very_seldom_have_spells_of_the_blues                                                                0.658
## During_the_past_few_years_I_have_been_well_most_of_the_time                                           0.666
## My_daily_life_is_full_of_things_that_keep_me_interested                                               0.747
## I_am_usually_calm_and_not_easily_upset                                                                0.661
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                              0.666
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                      0.630
## I_am_liked_by_most_people_who_know_me                                                                 0.595
## I_am_not_easily_angered                                                                               0.546
## I_do_not_mind_meeting_strangers                                                                       0.450
## I_get_all_the_sympathy_I_should                                                                       0.582
## Little_interest_or_pleasure_in_doing_things                                                           0.829
## Feeling_down_depressed_or_hopeless                                                                    0.903
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                    0.803
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                               0.487
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                          0.494
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 0.838
## Feeling_panic_or_being_frightened                                                                     0.853
## Avoiding_situations_that_make_you_anxious                                                             0.720
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                         0.653
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                      0.765
## Thoughts_of_actually_hurting_yourself                                                                 0.798
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                  0.538
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking 0.528
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                         0.695
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home          0.720
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                   0.798
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                        0.707
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories       0.796
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                           0.828
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                            0.860
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                     0.291
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                              0.294
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                      0.470
## Life_satisfaction                                                                                     0.801
## Job_satisfaction                                                                                      0.604
## Social_satisfaction                                                                                   0.714
## Romantic_satisfaction                                                                                 0.537
## Mood_higher_means_better_mood                                                                         0.819
## Anxiety_levels_higher_means_less_anxious                                                              0.447
## In_most_ways_my_life_is_close_to_my_ideal                                                             0.722
## The_conditions_of_my_life_are_excellent                                                               0.711
## I_am_satisfied_with_my_life                                                                           0.774
## So_far_I_have_gotten_the_important_things_I_want_in_life                                              0.696
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                            0.571
##                                                                                                           h2
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               0.6571
## Most_of_the_time_I_feel_blue                                                                          0.7839
## I_often_feel_as_if_things_were_not_real                                                               0.4701
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                      0.6696
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                             0.6945
## I_feel_that_I_have_often_been_punished_without_cause                                                  0.5799
## Life_is_a_strain_for_me_much_of_the_time                                                              0.7480
## I_have_strange_and_peculiar_thoughts                                                                  0.3884
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up               0.6693
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything             0.5576
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to     0.5071
## At_times_I_think_I_am_no_good_at_all                                                                  0.6526
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                        0.4729
## I_am_happy_most_of_the_time                                                                           0.6221
## I_very_seldom_have_spells_of_the_blues                                                                0.4325
## During_the_past_few_years_I_have_been_well_most_of_the_time                                           0.4437
## My_daily_life_is_full_of_things_that_keep_me_interested                                               0.5586
## I_am_usually_calm_and_not_easily_upset                                                                0.4365
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                              0.4432
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                      0.3971
## I_am_liked_by_most_people_who_know_me                                                                 0.3541
## I_am_not_easily_angered                                                                               0.2986
## I_do_not_mind_meeting_strangers                                                                       0.2022
## I_get_all_the_sympathy_I_should                                                                       0.3382
## Little_interest_or_pleasure_in_doing_things                                                           0.6870
## Feeling_down_depressed_or_hopeless                                                                    0.8156
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                    0.6443
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                               0.2369
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                          0.2444
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 0.7028
## Feeling_panic_or_being_frightened                                                                     0.7277
## Avoiding_situations_that_make_you_anxious                                                             0.5182
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                         0.4265
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                      0.5859
## Thoughts_of_actually_hurting_yourself                                                                 0.6373
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                  0.2892
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking 0.2793
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                         0.4835
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home          0.5185
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                   0.6362
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                        0.4997
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories       0.6339
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                           0.6861
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                            0.7392
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                     0.0848
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                              0.0862
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                      0.2207
## Life_satisfaction                                                                                     0.6419
## Job_satisfaction                                                                                      0.3644
## Social_satisfaction                                                                                   0.5094
## Romantic_satisfaction                                                                                 0.2884
## Mood_higher_means_better_mood                                                                         0.6703
## Anxiety_levels_higher_means_less_anxious                                                              0.2000
## In_most_ways_my_life_is_close_to_my_ideal                                                             0.5211
## The_conditions_of_my_life_are_excellent                                                               0.5062
## I_am_satisfied_with_my_life                                                                           0.5986
## So_far_I_have_gotten_the_important_things_I_want_in_life                                              0.4842
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                            0.3263
## 
## SS loadings:  28.9 
## Proportion Var:  0.498 
## 
## Factor correlations: 
## 
##    F1
## F1  1
#plot scale function
plot(
  irt_mh_symptoms,
  type = "score"
)

#scores
irt_mh_symptoms_scores = fscores(irt_mh_symptoms, full.scores = T, full.scores.SE = T)
d$p_symptoms = irt_mh_symptoms_scores[, 1] %>% standardize()

#reliability
empirical_rxx(irt_mh_symptoms_scores)
##    F1 
## 0.966
marginal_rxx(irt_mh_symptoms)
## [1] 0.966
get_reliabilities(irt_mh_symptoms) %>% 
  ggplot(aes(z, rel)) +
  geom_line()

#plot
d %>% 
  GG_denhist("p_symptoms")
## `stat_bin()` using `bins = 30`. Pick better value with `binwidth`.

Diagnoses only

#heatmap of latent cors
mh_vars_num %>% select(-all_of(mh_vars_symptoms)) %>% 
  psych::mixedCor() %>% 
  .[["rho"]] %>% 
  GG_heatmap(color_label = "Latent correlation", short_x_labels = T, font_size = 3)
## Warning in cor.smooth(mat): Matrix was not positive definite, smoothing was
## done

GG_save("figs/diagnoses_cor_heatmap.png")

#numbers
mh_vars_num %>% select(-all_of(mh_vars_symptoms)) %>% 
  psych::mixedCor() %>% 
  .[["rho"]] %>% 
  kirkegaard::MAT_half() %>% 
  describe2()
## Warning in cor.smooth(mat): Matrix was not positive definite, smoothing was
## done
#counts of each diagnosis
mh_vars_num %>% select(-all_of(mh_vars_symptoms)) %>% map_dfr(~(. - 1)) %>% colMeans() %>% sort()
##        Paranoia_Paranoid_personality_disorder 
##                                       0.00204 
##                                 Schizophrenia 
##                                       0.00204 
##                 Schizoid_personality_disorder 
##                                       0.00204 
##              Anti_social_personality_disorder 
##                                       0.01431 
##                                Phobias_social 
##                                       0.01738 
##                              Specific_phobias 
##                                       0.01738 
##                        Non_alcohol_drug_abuse 
##                                       0.01943 
##               Borderline_Personality_Disorder 
##                                       0.01943 
##                  Autism_spectrum_disorder_ASD 
##                                       0.03170 
##             Obsessive_compulsive_disorder_OCD 
##                                       0.03885 
##                                    Bipolarity 
##                                       0.03988 
##                                 Alcohol_abuse 
##                                       0.04601 
##                                Panic_disorder 
##                                       0.05215 
##           Post_traumatic_stress_disorder_PTSD 
##                                       0.07464 
##                            Sleeping_disorders 
##                                       0.08998 
## Attention_deficit_hyperactivity_disorder_ADHD 
##                                       0.10838 
##                  General_Anxiety_Disorder_GAD 
##                                       0.20859 
##                                    Depression 
##                                       0.25256
mh_vars_num %>% select(-all_of(mh_vars_symptoms)) %>% map_dfr(~(. - 1)) %>% map_df(as.logical) %>% map_df(ordered) %>% GG_ordinal() +
  labs(
    fill = "Has diagnosis"
  )

GG_save("figs/diagnoses_counts.png")

#fit a model with diagnoses only
irt_mh_diag = mirt(
  mh_vars_num %>% select(-all_of(mh_vars_symptoms)),
  itemtype = mh_vars_options %>% slice(-mh_vars_symptoms_idx) %>% pull(itemtype),
  model = 1
)
## Iteration: 1, Log-Lik: -2959.734, Max-Change: 2.26702Iteration: 2, Log-Lik: -2839.244, Max-Change: 0.91097Iteration: 3, Log-Lik: -2804.854, Max-Change: 0.37436Iteration: 4, Log-Lik: -2791.188, Max-Change: 0.26860Iteration: 5, Log-Lik: -2785.334, Max-Change: 0.16748Iteration: 6, Log-Lik: -2782.963, Max-Change: 0.11723Iteration: 7, Log-Lik: -2780.956, Max-Change: 0.10253Iteration: 8, Log-Lik: -2780.582, Max-Change: 0.22686Iteration: 9, Log-Lik: -2780.371, Max-Change: 0.02745Iteration: 10, Log-Lik: -2780.331, Max-Change: 0.02607Iteration: 11, Log-Lik: -2780.210, Max-Change: 0.01955Iteration: 12, Log-Lik: -2780.130, Max-Change: 0.01137Iteration: 13, Log-Lik: -2780.056, Max-Change: 0.00819Iteration: 14, Log-Lik: -2780.025, Max-Change: 0.00559Iteration: 15, Log-Lik: -2780.004, Max-Change: 0.00464Iteration: 16, Log-Lik: -2779.958, Max-Change: 0.00089Iteration: 17, Log-Lik: -2779.958, Max-Change: 0.00071Iteration: 18, Log-Lik: -2779.957, Max-Change: 0.00063Iteration: 19, Log-Lik: -2779.956, Max-Change: 0.00091Iteration: 20, Log-Lik: -2779.956, Max-Change: 0.00020Iteration: 21, Log-Lik: -2779.956, Max-Change: 0.00067Iteration: 22, Log-Lik: -2779.956, Max-Change: 0.00015Iteration: 23, Log-Lik: -2779.956, Max-Change: 0.00048Iteration: 24, Log-Lik: -2779.956, Max-Change: 0.00011Iteration: 25, Log-Lik: -2779.956, Max-Change: 0.00008
irt_mh_diag
## 
## Call:
## mirt(data = mh_vars_num %>% select(-all_of(mh_vars_symptoms)), 
##     model = 1, itemtype = mh_vars_options %>% slice(-mh_vars_symptoms_idx) %>% 
##         pull(itemtype))
## 
## Full-information item factor analysis with 1 factor(s).
## Converged within 1e-04 tolerance after 25 EM iterations.
## mirt version: 1.44.0 
## M-step optimizer: BFGS 
## EM acceleration: Ramsay 
## Number of rectangular quadrature: 61
## Latent density type: Gaussian 
## 
## Log-likelihood = -2780
## Estimated parameters: 36 
## AIC = 5632
## BIC = 5808; SABIC = 5693
## G2 (262107) = 836, p = 1
## RMSEA = 0, CFI = NaN, TLI = NaN
irt_mh_diag %>% summary()
##                                                  F1    h2
## Attention_deficit_hyperactivity_disorder_ADHD 0.564 0.318
## Alcohol_abuse                                 0.542 0.294
## Non_alcohol_drug_abuse                        0.614 0.377
## Autism_spectrum_disorder_ASD                  0.574 0.329
## Anti_social_personality_disorder              0.760 0.577
## Bipolarity                                    0.679 0.461
## Borderline_Personality_Disorder               0.830 0.689
## Depression                                    0.855 0.731
## General_Anxiety_Disorder_GAD                  0.863 0.744
## Obsessive_compulsive_disorder_OCD             0.698 0.487
## Panic_disorder                                0.816 0.667
## Paranoia_Paranoid_personality_disorder        0.567 0.322
## Phobias_social                                0.820 0.673
## Specific_phobias                              0.844 0.713
## Post_traumatic_stress_disorder_PTSD           0.840 0.705
## Schizophrenia                                 0.648 0.420
## Schizoid_personality_disorder                 0.842 0.710
## Sleeping_disorders                            0.716 0.512
## 
## SS loadings:  9.73 
## Proportion Var:  0.54 
## 
## Factor correlations: 
## 
##    F1
## F1  1
#plot scale function
plot(
  irt_mh_diag,
  type = "score"
)

#scores
irt_mh_diag_scores = fscores(irt_mh_diag, full.scores = T, full.scores.SE = T)
d$p_diag = irt_mh_diag_scores[, 1] %>% standardize()

#reliability
empirical_rxx(irt_mh_diag_scores)
##    F1 
## 0.599
marginal_rxx(irt_mh_diag)
## [1] 0.547
get_reliabilities(irt_mh_diag) %>% 
  ggplot(aes(z, rel)) +
  geom_line()

#plot
d %>% 
  GG_denhist("p_diag")
## `stat_bin()` using `bins = 30`. Pick better value with `binwidth`.

Comparison with symptoms

#compare
GG_scatter(d, "p_symptoms", "p_diag")
## `geom_smooth()` using formula = 'y ~ x'

#count of diagnoses
d$P_diag_count = mh_vars_num %>% select(-all_of(mh_vars_symptoms)) %>% map_df(~(. - 1)) %>% rowSums(na.rm = T)
d$P_diag_count %>% table2()
d$P_diag_count2 = d$P_diag_count %>% as.factor() %>% fct_lump_min(20, other_level = "5+")
d$P_diag_count2 %>% table2()
d$P_diag_any = d$P_diag_count > 0

#cohen d
SMD_matrix(d$p_symptoms, d$P_diag_any)
##        FALSE   TRUE
## FALSE     NA -0.914
## TRUE  -0.914     NA
SMD_matrix(d$p_symptoms, d$P_diag_count2)
##         0      1      2      3      4     5+
## 0      NA -0.568 -0.806 -1.115 -1.290 -1.691
## 1  -0.568     NA -0.238 -0.547 -0.723 -1.123
## 2  -0.806 -0.238     NA -0.310 -0.485 -0.885
## 3  -1.115 -0.547 -0.310     NA -0.175 -0.576
## 4  -1.290 -0.723 -0.485 -0.175     NA -0.401
## 5+ -1.691 -1.123 -0.885 -0.576 -0.401     NA
GG_group_means(d, "p_symptoms", "P_diag_count2", type = "violin") +
  labs(
    x = "Count of diagnoses",
    y = "Symptoms (IRT score)"
  )

GG_save("figs/p symptoms by diagnoses.png")

MMPI only

#item cors
mh_vars_num %>% select(
    Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen:I_get_all_the_sympathy_I_should
  ) %>% 
  psych::mixedCor() %>%
  .[["rho"]] %>%
  GG_heatmap(color_label = "Latent correlation", short_x_labels = T)

#MMPI items fit
irt_mh_mmpi = mirt(
  mh_vars_num %>% select(
    Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen:I_get_all_the_sympathy_I_should
  ),
  model = 1,
)
## Iteration: 1, Log-Lik: -10628.125, Max-Change: 0.78877Iteration: 2, Log-Lik: -10234.763, Max-Change: 0.62683Iteration: 3, Log-Lik: -10136.724, Max-Change: 0.35989Iteration: 4, Log-Lik: -10098.956, Max-Change: 0.26196Iteration: 5, Log-Lik: -10080.702, Max-Change: 0.18262Iteration: 6, Log-Lik: -10070.942, Max-Change: 0.15110Iteration: 7, Log-Lik: -10065.596, Max-Change: 0.11603Iteration: 8, Log-Lik: -10062.451, Max-Change: 0.08908Iteration: 9, Log-Lik: -10060.566, Max-Change: 0.05266Iteration: 10, Log-Lik: -10058.477, Max-Change: 0.03398Iteration: 11, Log-Lik: -10057.784, Max-Change: 0.02522Iteration: 12, Log-Lik: -10057.326, Max-Change: 0.02057Iteration: 13, Log-Lik: -10056.456, Max-Change: 0.01197Iteration: 14, Log-Lik: -10056.242, Max-Change: 0.01125Iteration: 15, Log-Lik: -10056.060, Max-Change: 0.00947Iteration: 16, Log-Lik: -10055.626, Max-Change: 0.00948Iteration: 17, Log-Lik: -10055.505, Max-Change: 0.00928Iteration: 18, Log-Lik: -10055.418, Max-Change: 0.00756Iteration: 19, Log-Lik: -10055.222, Max-Change: 0.00712Iteration: 20, Log-Lik: -10055.166, Max-Change: 0.00518Iteration: 21, Log-Lik: -10055.121, Max-Change: 0.00527Iteration: 22, Log-Lik: -10054.922, Max-Change: 0.00342Iteration: 23, Log-Lik: -10054.907, Max-Change: 0.00331Iteration: 24, Log-Lik: -10054.893, Max-Change: 0.00306Iteration: 25, Log-Lik: -10054.834, Max-Change: 0.00230Iteration: 26, Log-Lik: -10054.829, Max-Change: 0.00189Iteration: 27, Log-Lik: -10054.825, Max-Change: 0.00143Iteration: 28, Log-Lik: -10054.813, Max-Change: 0.00145Iteration: 29, Log-Lik: -10054.811, Max-Change: 0.00106Iteration: 30, Log-Lik: -10054.809, Max-Change: 0.00112Iteration: 31, Log-Lik: -10054.801, Max-Change: 0.00061Iteration: 32, Log-Lik: -10054.801, Max-Change: 0.00074Iteration: 33, Log-Lik: -10054.800, Max-Change: 0.00064Iteration: 34, Log-Lik: -10054.798, Max-Change: 0.00087Iteration: 35, Log-Lik: -10054.797, Max-Change: 0.00044Iteration: 36, Log-Lik: -10054.797, Max-Change: 0.00044Iteration: 37, Log-Lik: -10054.797, Max-Change: 0.00035Iteration: 38, Log-Lik: -10054.797, Max-Change: 0.00032Iteration: 39, Log-Lik: -10054.797, Max-Change: 0.00030Iteration: 40, Log-Lik: -10054.797, Max-Change: 0.00044Iteration: 41, Log-Lik: -10054.796, Max-Change: 0.00024Iteration: 42, Log-Lik: -10054.796, Max-Change: 0.00023Iteration: 43, Log-Lik: -10054.796, Max-Change: 0.00021Iteration: 44, Log-Lik: -10054.796, Max-Change: 0.00020Iteration: 45, Log-Lik: -10054.796, Max-Change: 0.00018Iteration: 46, Log-Lik: -10054.796, Max-Change: 0.00024Iteration: 47, Log-Lik: -10054.796, Max-Change: 0.00015Iteration: 48, Log-Lik: -10054.796, Max-Change: 0.00014Iteration: 49, Log-Lik: -10054.796, Max-Change: 0.00013Iteration: 50, Log-Lik: -10054.796, Max-Change: 0.00013Iteration: 51, Log-Lik: -10054.796, Max-Change: 0.00012Iteration: 52, Log-Lik: -10054.796, Max-Change: 0.00014Iteration: 53, Log-Lik: -10054.796, Max-Change: 0.00010Iteration: 54, Log-Lik: -10054.796, Max-Change: 0.00010
irt_mh_mmpi
## 
## Call:
## mirt(data = mh_vars_num %>% select(Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen:I_get_all_the_sympathy_I_should), 
##     model = 1)
## 
## Full-information item factor analysis with 1 factor(s).
## Converged within 1e-04 tolerance after 54 EM iterations.
## mirt version: 1.44.0 
## M-step optimizer: BFGS 
## EM acceleration: Ramsay 
## Number of rectangular quadrature: 61
## Latent density type: Gaussian 
## 
## Log-likelihood = -10055
## Estimated parameters: 48 
## AIC = 20206
## BIC = 20440; SABIC = 20288
## G2 (16777167) = 9179, p = 1
## RMSEA = 0, CFI = NaN, TLI = NaN
irt_mh_mmpi %>% summary()
##                                                                                                      F1
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                           0.834
## Most_of_the_time_I_feel_blue                                                                      0.905
## I_often_feel_as_if_things_were_not_real                                                           0.735
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                  0.858
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                         0.846
## I_feel_that_I_have_often_been_punished_without_cause                                              0.813
## Life_is_a_strain_for_me_much_of_the_time                                                          0.899
## I_have_strange_and_peculiar_thoughts                                                              0.657
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up           0.850
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything         0.763
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to 0.769
## At_times_I_think_I_am_no_good_at_all                                                              0.857
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                    0.730
## I_am_happy_most_of_the_time                                                                       0.805
## I_very_seldom_have_spells_of_the_blues                                                            0.713
## During_the_past_few_years_I_have_been_well_most_of_the_time                                       0.680
## My_daily_life_is_full_of_things_that_keep_me_interested                                           0.754
## I_am_usually_calm_and_not_easily_upset                                                            0.718
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                          0.672
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                  0.645
## I_am_liked_by_most_people_who_know_me                                                             0.653
## I_am_not_easily_angered                                                                           0.617
## I_do_not_mind_meeting_strangers                                                                   0.490
## I_get_all_the_sympathy_I_should                                                                   0.628
##                                                                                                      h2
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                           0.695
## Most_of_the_time_I_feel_blue                                                                      0.819
## I_often_feel_as_if_things_were_not_real                                                           0.541
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                  0.737
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                         0.716
## I_feel_that_I_have_often_been_punished_without_cause                                              0.662
## Life_is_a_strain_for_me_much_of_the_time                                                          0.809
## I_have_strange_and_peculiar_thoughts                                                              0.431
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up           0.722
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything         0.582
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to 0.591
## At_times_I_think_I_am_no_good_at_all                                                              0.734
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                    0.533
## I_am_happy_most_of_the_time                                                                       0.649
## I_very_seldom_have_spells_of_the_blues                                                            0.508
## During_the_past_few_years_I_have_been_well_most_of_the_time                                       0.462
## My_daily_life_is_full_of_things_that_keep_me_interested                                           0.568
## I_am_usually_calm_and_not_easily_upset                                                            0.515
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                          0.451
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                  0.416
## I_am_liked_by_most_people_who_know_me                                                             0.427
## I_am_not_easily_angered                                                                           0.381
## I_do_not_mind_meeting_strangers                                                                   0.240
## I_get_all_the_sympathy_I_should                                                                   0.394
## 
## SS loadings:  13.6 
## Proportion Var:  0.566 
## 
## Factor correlations: 
## 
##    F1
## F1  1
#plot scale function
plot(
  irt_mh_mmpi,
  type = "score"
)

#plot item functions
plot(
  irt_mh_mmpi,
  type = "trace"
)

#scores
irt_mh_mmpi_scores = fscores(irt_mh_mmpi, full.scores = T, full.scores.SE = T)
d$p_mmpi = irt_mh_mmpi_scores[, 1] %>% standardize()

#reliability
empirical_rxx(irt_mh_mmpi_scores)
##    F1 
## 0.851
marginal_rxx(irt_mh_mmpi)
## [1] 0.831
get_reliabilities(irt_mh_mmpi) %>% 
  ggplot(aes(z, rel)) +
  geom_line()

#plot scores
d %>% 
  GG_denhist("p_mmpi")
## `stat_bin()` using `bins = 30`. Pick better value with `binwidth`.

Last 2 weeks

#last 2 weeks items fit
irt_mh_last2weeks = mirt(
  mh_vars_num %>% select(Little_interest_or_pleasure_in_doing_things:Using_any_of_the_following_medicines_ON_YOUR_OWN),
  itemtype = "graded",
  model = 1
)
## Iteration: 1, Log-Lik: -20832.286, Max-Change: 3.34204Iteration: 2, Log-Lik: -19929.474, Max-Change: 1.07182Iteration: 3, Log-Lik: -19774.154, Max-Change: 0.45882Iteration: 4, Log-Lik: -19709.234, Max-Change: 0.19396Iteration: 5, Log-Lik: -19665.609, Max-Change: 0.13948Iteration: 6, Log-Lik: -19635.996, Max-Change: 0.10491Iteration: 7, Log-Lik: -19614.685, Max-Change: 0.15725Iteration: 8, Log-Lik: -19599.800, Max-Change: 0.12546Iteration: 9, Log-Lik: -19589.936, Max-Change: 0.18390Iteration: 10, Log-Lik: -19582.724, Max-Change: 0.13221Iteration: 11, Log-Lik: -19576.902, Max-Change: 0.14946Iteration: 12, Log-Lik: -19572.270, Max-Change: 0.10134Iteration: 13, Log-Lik: -19568.521, Max-Change: 0.09331Iteration: 14, Log-Lik: -19565.134, Max-Change: 0.07681Iteration: 15, Log-Lik: -19562.261, Max-Change: 0.06670Iteration: 16, Log-Lik: -19560.789, Max-Change: 0.04381Iteration: 17, Log-Lik: -19558.377, Max-Change: 0.05111Iteration: 18, Log-Lik: -19556.331, Max-Change: 0.08628Iteration: 19, Log-Lik: -19554.713, Max-Change: 0.07902Iteration: 20, Log-Lik: -19553.029, Max-Change: 0.10570Iteration: 21, Log-Lik: -19551.396, Max-Change: 0.10542Iteration: 22, Log-Lik: -19550.545, Max-Change: 0.02031Iteration: 23, Log-Lik: -19549.573, Max-Change: 0.01589Iteration: 24, Log-Lik: -19548.756, Max-Change: 0.01638Iteration: 25, Log-Lik: -19547.371, Max-Change: 0.02461Iteration: 26, Log-Lik: -19546.699, Max-Change: 0.02041Iteration: 27, Log-Lik: -19546.127, Max-Change: 0.00959Iteration: 28, Log-Lik: -19545.574, Max-Change: 0.01016Iteration: 29, Log-Lik: -19545.140, Max-Change: 0.00875Iteration: 30, Log-Lik: -19544.740, Max-Change: 0.00795Iteration: 31, Log-Lik: -19542.805, Max-Change: 0.00766Iteration: 32, Log-Lik: -19542.606, Max-Change: 0.01590Iteration: 33, Log-Lik: -19542.419, Max-Change: 0.00829Iteration: 34, Log-Lik: -19542.119, Max-Change: 0.00991Iteration: 35, Log-Lik: -19541.969, Max-Change: 0.00802Iteration: 36, Log-Lik: -19541.828, Max-Change: 0.00648Iteration: 37, Log-Lik: -19541.400, Max-Change: 0.01385Iteration: 38, Log-Lik: -19541.305, Max-Change: 0.00530Iteration: 39, Log-Lik: -19541.222, Max-Change: 0.01025Iteration: 40, Log-Lik: -19541.098, Max-Change: 0.00618Iteration: 41, Log-Lik: -19541.026, Max-Change: 0.00491Iteration: 42, Log-Lik: -19540.966, Max-Change: 0.00725Iteration: 43, Log-Lik: -19540.880, Max-Change: 0.00449Iteration: 44, Log-Lik: -19540.825, Max-Change: 0.01338Iteration: 45, Log-Lik: -19540.774, Max-Change: 0.00361Iteration: 46, Log-Lik: -19540.749, Max-Change: 0.00408Iteration: 47, Log-Lik: -19540.705, Max-Change: 0.01019Iteration: 48, Log-Lik: -19540.663, Max-Change: 0.00398Iteration: 49, Log-Lik: -19540.645, Max-Change: 0.00364Iteration: 50, Log-Lik: -19540.611, Max-Change: 0.00277Iteration: 51, Log-Lik: -19540.584, Max-Change: 0.00615Iteration: 52, Log-Lik: -19540.531, Max-Change: 0.00389Iteration: 53, Log-Lik: -19540.508, Max-Change: 0.00241Iteration: 54, Log-Lik: -19540.486, Max-Change: 0.00391Iteration: 55, Log-Lik: -19540.451, Max-Change: 0.00239Iteration: 56, Log-Lik: -19540.431, Max-Change: 0.00208Iteration: 57, Log-Lik: -19540.413, Max-Change: 0.00266Iteration: 58, Log-Lik: -19540.356, Max-Change: 0.00946Iteration: 59, Log-Lik: -19540.331, Max-Change: 0.00268Iteration: 60, Log-Lik: -19540.324, Max-Change: 0.00239Iteration: 61, Log-Lik: -19540.308, Max-Change: 0.00222Iteration: 62, Log-Lik: -19540.298, Max-Change: 0.00206Iteration: 63, Log-Lik: -19540.288, Max-Change: 0.00143Iteration: 64, Log-Lik: -19540.280, Max-Change: 0.00397Iteration: 65, Log-Lik: -19540.270, Max-Change: 0.00206Iteration: 66, Log-Lik: -19540.265, Max-Change: 0.00109Iteration: 67, Log-Lik: -19540.258, Max-Change: 0.00351Iteration: 68, Log-Lik: -19540.251, Max-Change: 0.00176Iteration: 69, Log-Lik: -19540.245, Max-Change: 0.00116Iteration: 70, Log-Lik: -19540.240, Max-Change: 0.00335Iteration: 71, Log-Lik: -19540.235, Max-Change: 0.00160Iteration: 72, Log-Lik: -19540.229, Max-Change: 0.00108Iteration: 73, Log-Lik: -19540.226, Max-Change: 0.00061Iteration: 74, Log-Lik: -19540.223, Max-Change: 0.00126Iteration: 75, Log-Lik: -19540.219, Max-Change: 0.00164Iteration: 76, Log-Lik: -19540.218, Max-Change: 0.00472Iteration: 77, Log-Lik: -19540.209, Max-Change: 0.00094Iteration: 78, Log-Lik: -19540.207, Max-Change: 0.00118Iteration: 79, Log-Lik: -19540.201, Max-Change: 0.00089Iteration: 80, Log-Lik: -19540.198, Max-Change: 0.00060Iteration: 81, Log-Lik: -19540.197, Max-Change: 0.00096Iteration: 82, Log-Lik: -19540.193, Max-Change: 0.00499Iteration: 83, Log-Lik: -19540.188, Max-Change: 0.00082Iteration: 84, Log-Lik: -19540.186, Max-Change: 0.00116Iteration: 85, Log-Lik: -19540.184, Max-Change: 0.00123Iteration: 86, Log-Lik: -19540.182, Max-Change: 0.00031Iteration: 87, Log-Lik: -19540.182, Max-Change: 0.00024Iteration: 88, Log-Lik: -19540.182, Max-Change: 0.00058Iteration: 89, Log-Lik: -19540.181, Max-Change: 0.00049Iteration: 90, Log-Lik: -19540.180, Max-Change: 0.00087Iteration: 91, Log-Lik: -19540.180, Max-Change: 0.00021Iteration: 92, Log-Lik: -19540.180, Max-Change: 0.00061Iteration: 93, Log-Lik: -19540.180, Max-Change: 0.00199Iteration: 94, Log-Lik: -19540.178, Max-Change: 0.00079Iteration: 95, Log-Lik: -19540.177, Max-Change: 0.00017Iteration: 96, Log-Lik: -19540.177, Max-Change: 0.00015Iteration: 97, Log-Lik: -19540.177, Max-Change: 0.00051Iteration: 98, Log-Lik: -19540.176, Max-Change: 0.00084Iteration: 99, Log-Lik: -19540.176, Max-Change: 0.00058Iteration: 100, Log-Lik: -19540.176, Max-Change: 0.00058Iteration: 101, Log-Lik: -19540.176, Max-Change: 0.00092Iteration: 102, Log-Lik: -19540.176, Max-Change: 0.00063Iteration: 103, Log-Lik: -19540.175, Max-Change: 0.00014Iteration: 104, Log-Lik: -19540.175, Max-Change: 0.00056Iteration: 105, Log-Lik: -19540.175, Max-Change: 0.00076Iteration: 106, Log-Lik: -19540.175, Max-Change: 0.00014Iteration: 107, Log-Lik: -19540.175, Max-Change: 0.00056Iteration: 108, Log-Lik: -19540.174, Max-Change: 0.00076Iteration: 109, Log-Lik: -19540.174, Max-Change: 0.00013Iteration: 110, Log-Lik: -19540.174, Max-Change: 0.00053Iteration: 111, Log-Lik: -19540.174, Max-Change: 0.00071Iteration: 112, Log-Lik: -19540.174, Max-Change: 0.00012Iteration: 113, Log-Lik: -19540.174, Max-Change: 0.00051Iteration: 114, Log-Lik: -19540.174, Max-Change: 0.00069Iteration: 115, Log-Lik: -19540.173, Max-Change: 0.00012Iteration: 116, Log-Lik: -19540.173, Max-Change: 0.00050Iteration: 117, Log-Lik: -19540.173, Max-Change: 0.00066Iteration: 118, Log-Lik: -19540.173, Max-Change: 0.00011Iteration: 119, Log-Lik: -19540.173, Max-Change: 0.00048Iteration: 120, Log-Lik: -19540.173, Max-Change: 0.00064Iteration: 121, Log-Lik: -19540.173, Max-Change: 0.00011Iteration: 122, Log-Lik: -19540.172, Max-Change: 0.00047Iteration: 123, Log-Lik: -19540.172, Max-Change: 0.00062Iteration: 124, Log-Lik: -19540.172, Max-Change: 0.00011Iteration: 125, Log-Lik: -19540.172, Max-Change: 0.00045Iteration: 126, Log-Lik: -19540.172, Max-Change: 0.00060Iteration: 127, Log-Lik: -19540.172, Max-Change: 0.00010Iteration: 128, Log-Lik: -19540.172, Max-Change: 0.00044Iteration: 129, Log-Lik: -19540.172, Max-Change: 0.00059Iteration: 130, Log-Lik: -19540.171, Max-Change: 0.00010Iteration: 131, Log-Lik: -19540.171, Max-Change: 0.00043Iteration: 132, Log-Lik: -19540.171, Max-Change: 0.00057Iteration: 133, Log-Lik: -19540.171, Max-Change: 0.00010
irt_mh_last2weeks
## 
## Call:
## mirt(data = mh_vars_num %>% select(Little_interest_or_pleasure_in_doing_things:Using_any_of_the_following_medicines_ON_YOUR_OWN), 
##     model = 1, itemtype = "graded")
## 
## Full-information item factor analysis with 1 factor(s).
## Converged within 1e-04 tolerance after 133 EM iterations.
## mirt version: 1.44.0 
## M-step optimizer: BFGS 
## EM acceleration: Ramsay 
## Number of rectangular quadrature: 61
## Latent density type: Gaussian 
## 
## Log-likelihood = -19540
## Estimated parameters: 115 
## AIC = 39310
## BIC = 39872; SABIC = 39507
## G2 (1e+10) = 26576, p = 1
## RMSEA = 0, CFI = NaN, TLI = NaN
irt_mh_last2weeks %>% summary()
##                                                                                                          F1
## Little_interest_or_pleasure_in_doing_things                                                           0.838
## Feeling_down_depressed_or_hopeless                                                                    0.868
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                    0.817
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                               0.588
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                          0.672
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 0.849
## Feeling_panic_or_being_frightened                                                                     0.891
## Avoiding_situations_that_make_you_anxious                                                             0.750
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                         0.729
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                      0.805
## Thoughts_of_actually_hurting_yourself                                                                 0.888
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                  0.777
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking 0.771
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                         0.704
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home          0.799
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                   0.864
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                        0.824
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories       0.888
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                           0.838
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                            0.849
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                     0.432
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                              0.380
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                      0.584
##                                                                                                          h2
## Little_interest_or_pleasure_in_doing_things                                                           0.703
## Feeling_down_depressed_or_hopeless                                                                    0.754
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                    0.668
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                               0.346
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                          0.452
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 0.721
## Feeling_panic_or_being_frightened                                                                     0.794
## Avoiding_situations_that_make_you_anxious                                                             0.563
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                         0.531
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                      0.649
## Thoughts_of_actually_hurting_yourself                                                                 0.789
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                  0.604
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking 0.594
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                         0.496
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home          0.639
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                   0.746
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                        0.680
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories       0.789
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                           0.703
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                            0.721
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                     0.186
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                              0.144
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                      0.341
## 
## SS loadings:  13.6 
## Proportion Var:  0.592 
## 
## Factor correlations: 
## 
##    F1
## F1  1
#plot scale function
plot(
  irt_mh_last2weeks,
  type = "score"
)

#scores
irt_mh_last2weeks_scores = fscores(irt_mh_last2weeks, full.scores = T, full.scores.SE = T)
d$p_last2weeks = irt_mh_last2weeks_scores[, 1] %>% standardize()

#reliability
empirical_rxx(irt_mh_last2weeks_scores)
##    F1 
## 0.922
marginal_rxx(irt_mh_last2weeks)
## [1] 0.915
get_reliabilities(irt_mh_last2weeks) %>% 
  ggplot(aes(z, rel)) +
  geom_line()

#plot scores
d %>% 
  GG_denhist("p_last2weeks")
## `stat_bin()` using `bins = 30`. Pick better value with `binwidth`.

Satisfaction

#satisfaction items fit
irt_mh_satisfaction = mirt(
  mh_vars_num %>% select(Life_satisfaction:If_I_could_live_my_life_over_I_would_change_almost_nothing),
  itemtype = "graded",
  model = 1
)
## Iteration: 1, Log-Lik: -17261.348, Max-Change: 4.74325Iteration: 2, Log-Lik: -15966.731, Max-Change: 3.23578Iteration: 3, Log-Lik: -15559.911, Max-Change: 0.79657Iteration: 4, Log-Lik: -15449.248, Max-Change: 0.42745Iteration: 5, Log-Lik: -15412.663, Max-Change: 0.25303Iteration: 6, Log-Lik: -15390.040, Max-Change: 0.26829Iteration: 7, Log-Lik: -15372.920, Max-Change: 0.25317Iteration: 8, Log-Lik: -15358.428, Max-Change: 0.28573Iteration: 9, Log-Lik: -15347.268, Max-Change: 0.23856Iteration: 10, Log-Lik: -15337.766, Max-Change: 0.15906Iteration: 11, Log-Lik: -15329.978, Max-Change: 0.14260Iteration: 12, Log-Lik: -15323.443, Max-Change: 0.18383Iteration: 13, Log-Lik: -15318.689, Max-Change: 0.15645Iteration: 14, Log-Lik: -15314.484, Max-Change: 0.11813Iteration: 15, Log-Lik: -15310.902, Max-Change: 0.08488Iteration: 16, Log-Lik: -15309.104, Max-Change: 0.07564Iteration: 17, Log-Lik: -15306.101, Max-Change: 0.11286Iteration: 18, Log-Lik: -15303.773, Max-Change: 0.14263Iteration: 19, Log-Lik: -15302.805, Max-Change: 0.06045Iteration: 20, Log-Lik: -15300.835, Max-Change: 0.05264Iteration: 21, Log-Lik: -15299.275, Max-Change: 0.05683Iteration: 22, Log-Lik: -15298.465, Max-Change: 0.03498Iteration: 23, Log-Lik: -15297.334, Max-Change: 0.04078Iteration: 24, Log-Lik: -15296.400, Max-Change: 0.03481Iteration: 25, Log-Lik: -15295.799, Max-Change: 0.02733Iteration: 26, Log-Lik: -15295.154, Max-Change: 0.02865Iteration: 27, Log-Lik: -15294.633, Max-Change: 0.02498Iteration: 28, Log-Lik: -15293.955, Max-Change: 0.02598Iteration: 29, Log-Lik: -15293.548, Max-Change: 0.02088Iteration: 30, Log-Lik: -15293.221, Max-Change: 0.02120Iteration: 31, Log-Lik: -15292.434, Max-Change: 0.01682Iteration: 32, Log-Lik: -15292.263, Max-Change: 0.01302Iteration: 33, Log-Lik: -15292.118, Max-Change: 0.01547Iteration: 34, Log-Lik: -15291.939, Max-Change: 0.01055Iteration: 35, Log-Lik: -15291.841, Max-Change: 0.01192Iteration: 36, Log-Lik: -15291.756, Max-Change: 0.00938Iteration: 37, Log-Lik: -15291.630, Max-Change: 0.01070Iteration: 38, Log-Lik: -15291.575, Max-Change: 0.00654Iteration: 39, Log-Lik: -15291.527, Max-Change: 0.00763Iteration: 40, Log-Lik: -15291.453, Max-Change: 0.00597Iteration: 41, Log-Lik: -15291.421, Max-Change: 0.00573Iteration: 42, Log-Lik: -15291.393, Max-Change: 0.00552Iteration: 43, Log-Lik: -15291.306, Max-Change: 0.01023Iteration: 44, Log-Lik: -15291.261, Max-Change: 0.00390Iteration: 45, Log-Lik: -15291.251, Max-Change: 0.00270Iteration: 46, Log-Lik: -15291.233, Max-Change: 0.00199Iteration: 47, Log-Lik: -15291.230, Max-Change: 0.00167Iteration: 48, Log-Lik: -15291.224, Max-Change: 0.00189Iteration: 49, Log-Lik: -15291.212, Max-Change: 0.00156Iteration: 50, Log-Lik: -15291.208, Max-Change: 0.00112Iteration: 51, Log-Lik: -15291.206, Max-Change: 0.00105Iteration: 52, Log-Lik: -15291.200, Max-Change: 0.00155Iteration: 53, Log-Lik: -15291.198, Max-Change: 0.00075Iteration: 54, Log-Lik: -15291.196, Max-Change: 0.00081Iteration: 55, Log-Lik: -15291.190, Max-Change: 0.00066Iteration: 56, Log-Lik: -15291.189, Max-Change: 0.00177Iteration: 57, Log-Lik: -15291.188, Max-Change: 0.00188Iteration: 58, Log-Lik: -15291.183, Max-Change: 0.00108Iteration: 59, Log-Lik: -15291.181, Max-Change: 0.00068Iteration: 60, Log-Lik: -15291.180, Max-Change: 0.00055Iteration: 61, Log-Lik: -15291.180, Max-Change: 0.00057Iteration: 62, Log-Lik: -15291.180, Max-Change: 0.00024Iteration: 63, Log-Lik: -15291.179, Max-Change: 0.00022Iteration: 64, Log-Lik: -15291.179, Max-Change: 0.00053Iteration: 65, Log-Lik: -15291.179, Max-Change: 0.00090Iteration: 66, Log-Lik: -15291.179, Max-Change: 0.00074Iteration: 67, Log-Lik: -15291.179, Max-Change: 0.00158Iteration: 68, Log-Lik: -15291.177, Max-Change: 0.00067Iteration: 69, Log-Lik: -15291.176, Max-Change: 0.00035Iteration: 70, Log-Lik: -15291.176, Max-Change: 0.00019Iteration: 71, Log-Lik: -15291.176, Max-Change: 0.00017Iteration: 72, Log-Lik: -15291.176, Max-Change: 0.00014Iteration: 73, Log-Lik: -15291.176, Max-Change: 0.00068Iteration: 74, Log-Lik: -15291.176, Max-Change: 0.00102Iteration: 75, Log-Lik: -15291.176, Max-Change: 0.00089Iteration: 76, Log-Lik: -15291.175, Max-Change: 0.00053Iteration: 77, Log-Lik: -15291.175, Max-Change: 0.00077Iteration: 78, Log-Lik: -15291.175, Max-Change: 0.00068Iteration: 79, Log-Lik: -15291.175, Max-Change: 0.00148Iteration: 80, Log-Lik: -15291.174, Max-Change: 0.00142Iteration: 81, Log-Lik: -15291.173, Max-Change: 0.00013Iteration: 82, Log-Lik: -15291.173, Max-Change: 0.00056Iteration: 83, Log-Lik: -15291.172, Max-Change: 0.00052Iteration: 84, Log-Lik: -15291.172, Max-Change: 0.00021Iteration: 85, Log-Lik: -15291.172, Max-Change: 0.00011Iteration: 86, Log-Lik: -15291.172, Max-Change: 0.00127Iteration: 87, Log-Lik: -15291.171, Max-Change: 0.00032Iteration: 88, Log-Lik: -15291.171, Max-Change: 0.00027Iteration: 89, Log-Lik: -15291.171, Max-Change: 0.00052Iteration: 90, Log-Lik: -15291.171, Max-Change: 0.00074Iteration: 91, Log-Lik: -15291.170, Max-Change: 0.00049Iteration: 92, Log-Lik: -15291.170, Max-Change: 0.00039Iteration: 93, Log-Lik: -15291.170, Max-Change: 0.00031Iteration: 94, Log-Lik: -15291.170, Max-Change: 0.00068Iteration: 95, Log-Lik: -15291.169, Max-Change: 0.00029Iteration: 96, Log-Lik: -15291.169, Max-Change: 0.00027Iteration: 97, Log-Lik: -15291.169, Max-Change: 0.00075Iteration: 98, Log-Lik: -15291.169, Max-Change: 0.00033Iteration: 99, Log-Lik: -15291.168, Max-Change: 0.00030Iteration: 100, Log-Lik: -15291.168, Max-Change: 0.00062Iteration: 101, Log-Lik: -15291.168, Max-Change: 0.00042Iteration: 102, Log-Lik: -15291.168, Max-Change: 0.00038Iteration: 103, Log-Lik: -15291.168, Max-Change: 0.00166Iteration: 104, Log-Lik: -15291.167, Max-Change: 0.00027Iteration: 105, Log-Lik: -15291.166, Max-Change: 0.00024Iteration: 106, Log-Lik: -15291.166, Max-Change: 0.00033Iteration: 107, Log-Lik: -15291.166, Max-Change: 0.00024Iteration: 108, Log-Lik: -15291.166, Max-Change: 0.00019Iteration: 109, Log-Lik: -15291.166, Max-Change: 0.00033Iteration: 110, Log-Lik: -15291.166, Max-Change: 0.00031Iteration: 111, Log-Lik: -15291.166, Max-Change: 0.00028Iteration: 112, Log-Lik: -15291.166, Max-Change: 0.00160Iteration: 113, Log-Lik: -15291.165, Max-Change: 0.00057Iteration: 114, Log-Lik: -15291.165, Max-Change: 0.00047Iteration: 115, Log-Lik: -15291.165, Max-Change: 0.00030Iteration: 116, Log-Lik: -15291.164, Max-Change: 0.00035Iteration: 117, Log-Lik: -15291.164, Max-Change: 0.00029Iteration: 118, Log-Lik: -15291.164, Max-Change: 0.00166Iteration: 119, Log-Lik: -15291.163, Max-Change: 0.00036Iteration: 120, Log-Lik: -15291.163, Max-Change: 0.00029Iteration: 121, Log-Lik: -15291.163, Max-Change: 0.00032Iteration: 122, Log-Lik: -15291.163, Max-Change: 0.00030Iteration: 123, Log-Lik: -15291.163, Max-Change: 0.00015Iteration: 124, Log-Lik: -15291.163, Max-Change: 0.00034Iteration: 125, Log-Lik: -15291.163, Max-Change: 0.00053Iteration: 126, Log-Lik: -15291.163, Max-Change: 0.00048Iteration: 127, Log-Lik: -15291.163, Max-Change: 0.00028Iteration: 128, Log-Lik: -15291.163, Max-Change: 0.00037Iteration: 129, Log-Lik: -15291.162, Max-Change: 0.00032Iteration: 130, Log-Lik: -15291.162, Max-Change: 0.00131Iteration: 131, Log-Lik: -15291.162, Max-Change: 0.00050Iteration: 132, Log-Lik: -15291.162, Max-Change: 0.00047Iteration: 133, Log-Lik: -15291.162, Max-Change: 0.00029Iteration: 134, Log-Lik: -15291.161, Max-Change: 0.00036Iteration: 135, Log-Lik: -15291.161, Max-Change: 0.00030Iteration: 136, Log-Lik: -15291.161, Max-Change: 0.00024Iteration: 137, Log-Lik: -15291.161, Max-Change: 0.00008
irt_mh_satisfaction
## 
## Call:
## mirt(data = mh_vars_num %>% select(Life_satisfaction:If_I_could_live_my_life_over_I_would_change_almost_nothing), 
##     model = 1, itemtype = "graded")
## 
## Full-information item factor analysis with 1 factor(s).
## Converged within 1e-04 tolerance after 137 EM iterations.
## mirt version: 1.44.0 
## M-step optimizer: BFGS 
## EM acceleration: Ramsay 
## Number of rectangular quadrature: 61
## Latent density type: Gaussian 
## 
## Log-likelihood = -15291
## Estimated parameters: 77 
## AIC = 30736
## BIC = 31113; SABIC = 30868
irt_mh_satisfaction %>% summary()
##                                                               F1    h2
## Life_satisfaction                                          0.928 0.862
## Job_satisfaction                                           0.749 0.560
## Social_satisfaction                                        0.801 0.642
## Romantic_satisfaction                                      0.715 0.511
## Mood_higher_means_better_mood                              0.841 0.707
## Anxiety_levels_higher_means_less_anxious                   0.433 0.187
## In_most_ways_my_life_is_close_to_my_ideal                  0.947 0.897
## The_conditions_of_my_life_are_excellent                    0.928 0.861
## I_am_satisfied_with_my_life                                0.960 0.921
## So_far_I_have_gotten_the_important_things_I_want_in_life   0.886 0.785
## If_I_could_live_my_life_over_I_would_change_almost_nothing 0.793 0.630
## 
## SS loadings:  7.56 
## Proportion Var:  0.688 
## 
## Factor correlations: 
## 
##    F1
## F1  1
#plot scale function
plot(
  irt_mh_satisfaction,
  type = "score"
)

#scores
irt_mh_satisfaction_scores = fscores(irt_mh_satisfaction, full.scores = T, full.scores.SE = T)
d$p_satisfaction = irt_mh_satisfaction_scores[, 1] %>% standardize()

#reliability
empirical_rxx(irt_mh_satisfaction_scores)
##    F1 
## 0.963
marginal_rxx(irt_mh_satisfaction)
## [1] 0.963
get_reliabilities(irt_mh_satisfaction) %>% 
  ggplot(aes(z, rel)) +
  geom_line()

#plot scores
d %>% 
  GG_denhist("p_satisfaction")
## `stat_bin()` using `bins = 30`. Pick better value with `binwidth`.

Ideology

#dimensionality
(unidem_pol = unidim(
  pol_vars_num,
  cor = "mixed"
))
## 
## A measure of unidimensionality 
##  Call: unidim(keys = pol_vars_num, cor = "mixed")
## 
## Unidimensionality index = 
##        u      tau    rho_c    alpha     av.r median.r      CFI      ECV 
##     0.73     0.77     0.95     0.96     0.35     0.37     0.62     0.77 
##    F1/F2      MAP 
##     4.81     0.03 
## 
## unidim adjusted index reverses negatively scored items.
## alpha    Based upon reverse scoring some items.
## average and median  correlations are based upon reversed scored items
#fit a full model with all items of all types
irt_pol_all = mirt(
  pol_vars_num,
  itemtype = pol_vars_options$itemtype,
  model = 1
)
## Iteration: 1, Log-Lik: -70868.186, Max-Change: 2.91228Iteration: 2, Log-Lik: -64057.133, Max-Change: 1.02316Iteration: 3, Log-Lik: -63091.100, Max-Change: 0.65212Iteration: 4, Log-Lik: -62951.070, Max-Change: 0.37279Iteration: 5, Log-Lik: -62894.942, Max-Change: 0.08779Iteration: 6, Log-Lik: -62885.952, Max-Change: 0.06001Iteration: 7, Log-Lik: -62883.341, Max-Change: 0.02913Iteration: 8, Log-Lik: -62881.705, Max-Change: 0.02891Iteration: 9, Log-Lik: -62880.432, Max-Change: 0.02635Iteration: 10, Log-Lik: -62879.429, Max-Change: 0.02758Iteration: 11, Log-Lik: -62878.446, Max-Change: 0.02098Iteration: 12, Log-Lik: -62877.708, Max-Change: 0.02777Iteration: 13, Log-Lik: -62876.690, Max-Change: 0.01502Iteration: 14, Log-Lik: -62876.103, Max-Change: 0.02244Iteration: 15, Log-Lik: -62875.686, Max-Change: 0.01318Iteration: 16, Log-Lik: -62875.324, Max-Change: 0.01048Iteration: 17, Log-Lik: -62875.028, Max-Change: 0.02066Iteration: 18, Log-Lik: -62874.761, Max-Change: 0.00835Iteration: 19, Log-Lik: -62874.586, Max-Change: 0.01044Iteration: 20, Log-Lik: -62874.380, Max-Change: 0.01079Iteration: 21, Log-Lik: -62874.202, Max-Change: 0.00809Iteration: 22, Log-Lik: -62874.015, Max-Change: 0.00661Iteration: 23, Log-Lik: -62873.895, Max-Change: 0.00588Iteration: 24, Log-Lik: -62873.802, Max-Change: 0.00638Iteration: 25, Log-Lik: -62873.481, Max-Change: 0.00475Iteration: 26, Log-Lik: -62873.412, Max-Change: 0.00277Iteration: 27, Log-Lik: -62873.381, Max-Change: 0.00500Iteration: 28, Log-Lik: -62873.321, Max-Change: 0.00227Iteration: 29, Log-Lik: -62873.300, Max-Change: 0.00238Iteration: 30, Log-Lik: -62873.283, Max-Change: 0.00253Iteration: 31, Log-Lik: -62873.212, Max-Change: 0.00177Iteration: 32, Log-Lik: -62873.204, Max-Change: 0.00288Iteration: 33, Log-Lik: -62873.194, Max-Change: 0.00247Iteration: 34, Log-Lik: -62873.190, Max-Change: 0.00113Iteration: 35, Log-Lik: -62873.186, Max-Change: 0.00086Iteration: 36, Log-Lik: -62873.184, Max-Change: 0.00059Iteration: 37, Log-Lik: -62873.183, Max-Change: 0.00034Iteration: 38, Log-Lik: -62873.182, Max-Change: 0.00034Iteration: 39, Log-Lik: -62873.181, Max-Change: 0.00045Iteration: 40, Log-Lik: -62873.180, Max-Change: 0.00080Iteration: 41, Log-Lik: -62873.180, Max-Change: 0.00108Iteration: 42, Log-Lik: -62873.179, Max-Change: 0.00146Iteration: 43, Log-Lik: -62873.178, Max-Change: 0.00076Iteration: 44, Log-Lik: -62873.178, Max-Change: 0.00103Iteration: 45, Log-Lik: -62873.177, Max-Change: 0.00140Iteration: 46, Log-Lik: -62873.176, Max-Change: 0.00073Iteration: 47, Log-Lik: -62873.176, Max-Change: 0.00099Iteration: 48, Log-Lik: -62873.176, Max-Change: 0.00134Iteration: 49, Log-Lik: -62873.175, Max-Change: 0.00068Iteration: 50, Log-Lik: -62873.174, Max-Change: 0.00093Iteration: 51, Log-Lik: -62873.174, Max-Change: 0.00126Iteration: 52, Log-Lik: -62873.173, Max-Change: 0.00066Iteration: 53, Log-Lik: -62873.173, Max-Change: 0.00089Iteration: 54, Log-Lik: -62873.173, Max-Change: 0.00120Iteration: 55, Log-Lik: -62873.172, Max-Change: 0.00061Iteration: 56, Log-Lik: -62873.172, Max-Change: 0.00084Iteration: 57, Log-Lik: -62873.172, Max-Change: 0.00113Iteration: 58, Log-Lik: -62873.171, Max-Change: 0.00059Iteration: 59, Log-Lik: -62873.171, Max-Change: 0.00080Iteration: 60, Log-Lik: -62873.170, Max-Change: 0.00108Iteration: 61, Log-Lik: -62873.170, Max-Change: 0.00055Iteration: 62, Log-Lik: -62873.170, Max-Change: 0.00075Iteration: 63, Log-Lik: -62873.169, Max-Change: 0.00102Iteration: 64, Log-Lik: -62873.169, Max-Change: 0.00053Iteration: 65, Log-Lik: -62873.169, Max-Change: 0.00072Iteration: 66, Log-Lik: -62873.169, Max-Change: 0.00097Iteration: 67, Log-Lik: -62873.168, Max-Change: 0.00050Iteration: 68, Log-Lik: -62873.168, Max-Change: 0.00068Iteration: 69, Log-Lik: -62873.168, Max-Change: 0.00092Iteration: 70, Log-Lik: -62873.167, Max-Change: 0.00048Iteration: 71, Log-Lik: -62873.167, Max-Change: 0.00065Iteration: 72, Log-Lik: -62873.167, Max-Change: 0.00088Iteration: 73, Log-Lik: -62873.167, Max-Change: 0.00045Iteration: 74, Log-Lik: -62873.167, Max-Change: 0.00061Iteration: 75, Log-Lik: -62873.166, Max-Change: 0.00083Iteration: 76, Log-Lik: -62873.166, Max-Change: 0.00043Iteration: 77, Log-Lik: -62873.166, Max-Change: 0.00058Iteration: 78, Log-Lik: -62873.166, Max-Change: 0.00079Iteration: 79, Log-Lik: -62873.166, Max-Change: 0.00041Iteration: 80, Log-Lik: -62873.165, Max-Change: 0.00055Iteration: 81, Log-Lik: -62873.165, Max-Change: 0.00075Iteration: 82, Log-Lik: -62873.165, Max-Change: 0.00039Iteration: 83, Log-Lik: -62873.165, Max-Change: 0.00053Iteration: 84, Log-Lik: -62873.165, Max-Change: 0.00072Iteration: 85, Log-Lik: -62873.165, Max-Change: 0.00037Iteration: 86, Log-Lik: -62873.164, Max-Change: 0.00050Iteration: 87, Log-Lik: -62873.164, Max-Change: 0.00068Iteration: 88, Log-Lik: -62873.164, Max-Change: 0.00036Iteration: 89, Log-Lik: -62873.164, Max-Change: 0.00048Iteration: 90, Log-Lik: -62873.164, Max-Change: 0.00065Iteration: 91, Log-Lik: -62873.164, Max-Change: 0.00034Iteration: 92, Log-Lik: -62873.164, Max-Change: 0.00046Iteration: 93, Log-Lik: -62873.164, Max-Change: 0.00062Iteration: 94, Log-Lik: -62873.163, Max-Change: 0.00032Iteration: 95, Log-Lik: -62873.163, Max-Change: 0.00044Iteration: 96, Log-Lik: -62873.163, Max-Change: 0.00059Iteration: 97, Log-Lik: -62873.163, Max-Change: 0.00031Iteration: 98, Log-Lik: -62873.163, Max-Change: 0.00042Iteration: 99, Log-Lik: -62873.163, Max-Change: 0.00056Iteration: 100, Log-Lik: -62873.163, Max-Change: 0.00029Iteration: 101, Log-Lik: -62873.163, Max-Change: 0.00040Iteration: 102, Log-Lik: -62873.163, Max-Change: 0.00054Iteration: 103, Log-Lik: -62873.163, Max-Change: 0.00028Iteration: 104, Log-Lik: -62873.162, Max-Change: 0.00038Iteration: 105, Log-Lik: -62873.162, Max-Change: 0.00051Iteration: 106, Log-Lik: -62873.162, Max-Change: 0.00027Iteration: 107, Log-Lik: -62873.162, Max-Change: 0.00036Iteration: 108, Log-Lik: -62873.162, Max-Change: 0.00049Iteration: 109, Log-Lik: -62873.162, Max-Change: 0.00025Iteration: 110, Log-Lik: -62873.162, Max-Change: 0.00035Iteration: 111, Log-Lik: -62873.162, Max-Change: 0.00047Iteration: 112, Log-Lik: -62873.162, Max-Change: 0.00025Iteration: 113, Log-Lik: -62873.162, Max-Change: 0.00033Iteration: 114, Log-Lik: -62873.162, Max-Change: 0.00045Iteration: 115, Log-Lik: -62873.162, Max-Change: 0.00023Iteration: 116, Log-Lik: -62873.162, Max-Change: 0.00032Iteration: 117, Log-Lik: -62873.162, Max-Change: 0.00043Iteration: 118, Log-Lik: -62873.162, Max-Change: 0.00023Iteration: 119, Log-Lik: -62873.161, Max-Change: 0.00030Iteration: 120, Log-Lik: -62873.161, Max-Change: 0.00041Iteration: 121, Log-Lik: -62873.161, Max-Change: 0.00021Iteration: 122, Log-Lik: -62873.161, Max-Change: 0.00029Iteration: 123, Log-Lik: -62873.161, Max-Change: 0.00039Iteration: 124, Log-Lik: -62873.161, Max-Change: 0.00021Iteration: 125, Log-Lik: -62873.161, Max-Change: 0.00028Iteration: 126, Log-Lik: -62873.161, Max-Change: 0.00038Iteration: 127, Log-Lik: -62873.161, Max-Change: 0.00020Iteration: 128, Log-Lik: -62873.161, Max-Change: 0.00027Iteration: 129, Log-Lik: -62873.161, Max-Change: 0.00036Iteration: 130, Log-Lik: -62873.161, Max-Change: 0.00019Iteration: 131, Log-Lik: -62873.161, Max-Change: 0.00026Iteration: 132, Log-Lik: -62873.161, Max-Change: 0.00035Iteration: 133, Log-Lik: -62873.161, Max-Change: 0.00018Iteration: 134, Log-Lik: -62873.161, Max-Change: 0.00025Iteration: 135, Log-Lik: -62873.161, Max-Change: 0.00034Iteration: 136, Log-Lik: -62873.161, Max-Change: 0.00018Iteration: 137, Log-Lik: -62873.161, Max-Change: 0.00024Iteration: 138, Log-Lik: -62873.161, Max-Change: 0.00033Iteration: 139, Log-Lik: -62873.161, Max-Change: 0.00017Iteration: 140, Log-Lik: -62873.161, Max-Change: 0.00023Iteration: 141, Log-Lik: -62873.161, Max-Change: 0.00031Iteration: 142, Log-Lik: -62873.161, Max-Change: 0.00016Iteration: 143, Log-Lik: -62873.161, Max-Change: 0.00022Iteration: 144, Log-Lik: -62873.161, Max-Change: 0.00030Iteration: 145, Log-Lik: -62873.160, Max-Change: 0.00016Iteration: 146, Log-Lik: -62873.160, Max-Change: 0.00022Iteration: 147, Log-Lik: -62873.160, Max-Change: 0.00029Iteration: 148, Log-Lik: -62873.160, Max-Change: 0.00015Iteration: 149, Log-Lik: -62873.160, Max-Change: 0.00021Iteration: 150, Log-Lik: -62873.160, Max-Change: 0.00028Iteration: 151, Log-Lik: -62873.160, Max-Change: 0.00015Iteration: 152, Log-Lik: -62873.160, Max-Change: 0.00020Iteration: 153, Log-Lik: -62873.160, Max-Change: 0.00027Iteration: 154, Log-Lik: -62873.160, Max-Change: 0.00014Iteration: 155, Log-Lik: -62873.160, Max-Change: 0.00019Iteration: 156, Log-Lik: -62873.160, Max-Change: 0.00026Iteration: 157, Log-Lik: -62873.160, Max-Change: 0.00014Iteration: 158, Log-Lik: -62873.160, Max-Change: 0.00019Iteration: 159, Log-Lik: -62873.160, Max-Change: 0.00025Iteration: 160, Log-Lik: -62873.160, Max-Change: 0.00013Iteration: 161, Log-Lik: -62873.160, Max-Change: 0.00018Iteration: 162, Log-Lik: -62873.160, Max-Change: 0.00025Iteration: 163, Log-Lik: -62873.160, Max-Change: 0.00013Iteration: 164, Log-Lik: -62873.160, Max-Change: 0.00018Iteration: 165, Log-Lik: -62873.160, Max-Change: 0.00024Iteration: 166, Log-Lik: -62873.160, Max-Change: 0.00013Iteration: 167, Log-Lik: -62873.160, Max-Change: 0.00017Iteration: 168, Log-Lik: -62873.160, Max-Change: 0.00023Iteration: 169, Log-Lik: -62873.160, Max-Change: 0.00012Iteration: 170, Log-Lik: -62873.160, Max-Change: 0.00017Iteration: 171, Log-Lik: -62873.160, Max-Change: 0.00022Iteration: 172, Log-Lik: -62873.160, Max-Change: 0.00012Iteration: 173, Log-Lik: -62873.160, Max-Change: 0.00016Iteration: 174, Log-Lik: -62873.160, Max-Change: 0.00022Iteration: 175, Log-Lik: -62873.160, Max-Change: 0.00012Iteration: 176, Log-Lik: -62873.160, Max-Change: 0.00016Iteration: 177, Log-Lik: -62873.160, Max-Change: 0.00021Iteration: 178, Log-Lik: -62873.160, Max-Change: 0.00011Iteration: 179, Log-Lik: -62873.160, Max-Change: 0.00015Iteration: 180, Log-Lik: -62873.160, Max-Change: 0.00021Iteration: 181, Log-Lik: -62873.160, Max-Change: 0.00011Iteration: 182, Log-Lik: -62873.160, Max-Change: 0.00015Iteration: 183, Log-Lik: -62873.160, Max-Change: 0.00020Iteration: 184, Log-Lik: -62873.160, Max-Change: 0.00011Iteration: 185, Log-Lik: -62873.160, Max-Change: 0.00015Iteration: 186, Log-Lik: -62873.160, Max-Change: 0.00020Iteration: 187, Log-Lik: -62873.160, Max-Change: 0.00010Iteration: 188, Log-Lik: -62873.160, Max-Change: 0.00014Iteration: 189, Log-Lik: -62873.160, Max-Change: 0.00019Iteration: 190, Log-Lik: -62873.160, Max-Change: 0.00010Iteration: 191, Log-Lik: -62873.160, Max-Change: 0.00014Iteration: 192, Log-Lik: -62873.160, Max-Change: 0.00019Iteration: 193, Log-Lik: -62873.160, Max-Change: 0.00010Iteration: 194, Log-Lik: -62873.160, Max-Change: 0.00014Iteration: 195, Log-Lik: -62873.160, Max-Change: 0.00018Iteration: 196, Log-Lik: -62873.160, Max-Change: 0.00010
irt_pol_all
## 
## Call:
## mirt(data = pol_vars_num, model = 1, itemtype = pol_vars_options$itemtype)
## 
## Full-information item factor analysis with 1 factor(s).
## Converged within 1e-04 tolerance after 196 EM iterations.
## mirt version: 1.44.0 
## M-step optimizer: BFGS 
## EM acceleration: Ramsay 
## Number of rectangular quadrature: 61
## Latent density type: Gaussian 
## 
## Log-likelihood = -62873
## Estimated parameters: 287 
## AIC = 126320
## BIC = 127722; SABIC = 126811
## G2 (1e+10) = 112278, p = 1
## RMSEA = 0, CFI = NaN, TLI = NaN
irt_pol_all %>% summary()
##                                                                                                                                                                                       F1
## There_are_objective_measures_of_beauty_How_much_do_you_agree_with_the_following_statements                                                                                        -0.292
## The_label_overweight_is_offensive_How_much_do_you_agree_with_the_following_statements                                                                                              0.107
## Beauty_standards_are_oppressive_How_much_do_you_agree_with_the_following_statements                                                                                                0.507
## Body_positivity_is_harmful_How_much_do_you_agree_with_the_following_statements                                                                                                    -0.282
## I_support_the_LGBT_community_How_much_do_you_agree_with_the_following_statements                                                                                                   0.888
## Homosexual_behavior_is_fine_when_it_is_private_and_chaste_How_much_do_you_agree_with_the_following_statements                                                                      0.106
## There_is_nothing_wrong_with_public_depictions_of_homosexual_relationships_How_much_do_you_agree_with_the_following_statements                                                      0.868
## I_support_gay_marriage_How_much_do_you_agree_with_the_following_statements                                                                                                         0.870
## There_is_nothing_wrong_with_attending_a_gay_orgy_How_much_do_you_agree_with_the_following_statements                                                                               0.763
## Children_should_be_taught_about_gay_sex_in_sex_education_classes_How_much_do_you_agree_with_the_following_statements                                                               0.776
## There_are_only_two_genders_How_much_do_you_agree_with_the_following_statements                                                                                                    -0.846
## Everyone_be_addressed_by_their_desired_pronouns_How_much_do_you_agree_with_the_following_statements                                                                                0.850
## I_support_feminism_How_much_do_you_agree_with_the_following_statements                                                                                                             0.835
## The_country_would_be_better_if_women_couldn_t_vote_How_much_do_you_agree_with_the_following_statements                                                                            -0.516
## Women_should_try_to_be_married_by_the_age_of_25_How_much_do_you_agree_with_the_following_statements                                                                               -0.501
## The_government_should_help_ensure_sexual_equality_by_making_sure_women_are_not_discriminated_against_in_private_hiring_How_much_do_you_agree_with_the_following_statements         0.693
## Women_should_hold_the_majority_of_the_positions_of_power_in_society_How_much_do_you_agree_with_the_following_statements                                                            0.542
## Marriage_is_oppressive_for_women_and_monogamy_should_be_moved_away_from_How_much_do_you_agree_with_the_following_statements                                                        0.420
## Men_should_be_masculine_and_women_should_be_feminine_How_much_do_you_agree_with_the_following_statements                                                                          -0.760
## Politics_suffers_from_male_overrepresentation_How_much_do_you_agree_with_the_following_statements                                                                                  0.806
## Abortion_should_be_available_to_women_for_use_for_any_reason_How_much_do_you_agree_with_the_following_statements                                                                   0.816
## I_support_sending_more_aid_to_Ukraine_How_much_do_you_agree_with_the_following_statements                                                                                          0.664
## The_Western_response_to_the_Russian_invasion_of_Ukraine_went_too_far_How_much_do_you_agree_with_the_following_statements                                                          -0.511
## Progressive_taxation_where_the_rich_are_taxed_at_a_higher_rate_is_the_best_way_to_structure_a_tax_system_How_much_do_you_agree_with_the_following_statements                       0.694
## Reducing_taxes_for_businesses_can_stimulate_economic_growth_How_much_do_you_agree_with_the_following_statements                                                                   -0.553
## I_support_Israel_against_Hamas_How_much_do_you_agree_with_the_following_statements                                                                                                -0.504
## Israel_is_commiting_genocide_in_Gaza_How_much_do_you_agree_with_the_following_statements                                                                                           0.647
## Black_Lives_Matter_is_a_virtuous_organization_How_much_do_you_agree_with_the_following_statements                                                                                  0.708
## Europe_would_be_best_if_it_remained_all_white_How_much_do_you_agree_with_the_following_statements                                                                                 -0.604
## Immigration_policy_should_be_strict_and_heavily_meritorious_How_much_do_you_agree_with_the_following_statements                                                                   -0.730
## The_government_should_ensure_racial_equality_by_prohibiting_racial_discrimination_in_private_business_dealings_such_as_hiring_How_much_do_you_agree_with_the_following_statements  0.641
## Black_people_deserve_reparations_for_the_legacy_of_slavery_How_much_do_you_agree_with_the_following_statements                                                                     0.622
## I_support_open_borders_How_much_do_you_agree_with_the_following_statements                                                                                                         0.615
## Politics_suffers_from_white_overrepresentation_How_much_do_you_agree_with_the_following_statements                                                                                 0.822
## Affirmative_action_is_discrimination_How_much_do_you_agree_with_the_following_statements                                                                                          -0.627
## Compared_to_other_civilizations_Western_civilization_is_uniquely_evil_How_much_do_you_agree_with_the_following_statements                                                          0.248
## Racial_diversity_is_more_important_than_viewpoint_diversity_How_much_do_you_agree_with_the_following_statements                                                                    0.434
## The_world_is_suffering_from_overpopulation_How_much_do_you_agree_with_the_following_statements                                                                                     0.380
## I_feel_overwhelmed_or_anxious_by_climate_change_How_much_do_you_agree_with_the_following_statements                                                                                0.651
## Public_policy_changes_do_not_need_to_be_made_to_deal_with_climate_change_How_much_do_you_agree_with_the_following_statements                                                      -0.670
## Are_you_politically_left_wing_or_right_wing                                                                                                                                       -0.767
##                                                                                                                                                                                       h2
## There_are_objective_measures_of_beauty_How_much_do_you_agree_with_the_following_statements                                                                                        0.0854
## The_label_overweight_is_offensive_How_much_do_you_agree_with_the_following_statements                                                                                             0.0115
## Beauty_standards_are_oppressive_How_much_do_you_agree_with_the_following_statements                                                                                               0.2574
## Body_positivity_is_harmful_How_much_do_you_agree_with_the_following_statements                                                                                                    0.0798
## I_support_the_LGBT_community_How_much_do_you_agree_with_the_following_statements                                                                                                  0.7894
## Homosexual_behavior_is_fine_when_it_is_private_and_chaste_How_much_do_you_agree_with_the_following_statements                                                                     0.0113
## There_is_nothing_wrong_with_public_depictions_of_homosexual_relationships_How_much_do_you_agree_with_the_following_statements                                                     0.7531
## I_support_gay_marriage_How_much_do_you_agree_with_the_following_statements                                                                                                        0.7570
## There_is_nothing_wrong_with_attending_a_gay_orgy_How_much_do_you_agree_with_the_following_statements                                                                              0.5826
## Children_should_be_taught_about_gay_sex_in_sex_education_classes_How_much_do_you_agree_with_the_following_statements                                                              0.6018
## There_are_only_two_genders_How_much_do_you_agree_with_the_following_statements                                                                                                    0.7155
## Everyone_be_addressed_by_their_desired_pronouns_How_much_do_you_agree_with_the_following_statements                                                                               0.7224
## I_support_feminism_How_much_do_you_agree_with_the_following_statements                                                                                                            0.6978
## The_country_would_be_better_if_women_couldn_t_vote_How_much_do_you_agree_with_the_following_statements                                                                            0.2663
## Women_should_try_to_be_married_by_the_age_of_25_How_much_do_you_agree_with_the_following_statements                                                                               0.2507
## The_government_should_help_ensure_sexual_equality_by_making_sure_women_are_not_discriminated_against_in_private_hiring_How_much_do_you_agree_with_the_following_statements        0.4808
## Women_should_hold_the_majority_of_the_positions_of_power_in_society_How_much_do_you_agree_with_the_following_statements                                                           0.2940
## Marriage_is_oppressive_for_women_and_monogamy_should_be_moved_away_from_How_much_do_you_agree_with_the_following_statements                                                       0.1764
## Men_should_be_masculine_and_women_should_be_feminine_How_much_do_you_agree_with_the_following_statements                                                                          0.5782
## Politics_suffers_from_male_overrepresentation_How_much_do_you_agree_with_the_following_statements                                                                                 0.6494
## Abortion_should_be_available_to_women_for_use_for_any_reason_How_much_do_you_agree_with_the_following_statements                                                                  0.6663
## I_support_sending_more_aid_to_Ukraine_How_much_do_you_agree_with_the_following_statements                                                                                         0.4404
## The_Western_response_to_the_Russian_invasion_of_Ukraine_went_too_far_How_much_do_you_agree_with_the_following_statements                                                          0.2608
## Progressive_taxation_where_the_rich_are_taxed_at_a_higher_rate_is_the_best_way_to_structure_a_tax_system_How_much_do_you_agree_with_the_following_statements                      0.4818
## Reducing_taxes_for_businesses_can_stimulate_economic_growth_How_much_do_you_agree_with_the_following_statements                                                                   0.3054
## I_support_Israel_against_Hamas_How_much_do_you_agree_with_the_following_statements                                                                                                0.2539
## Israel_is_commiting_genocide_in_Gaza_How_much_do_you_agree_with_the_following_statements                                                                                          0.4189
## Black_Lives_Matter_is_a_virtuous_organization_How_much_do_you_agree_with_the_following_statements                                                                                 0.5016
## Europe_would_be_best_if_it_remained_all_white_How_much_do_you_agree_with_the_following_statements                                                                                 0.3647
## Immigration_policy_should_be_strict_and_heavily_meritorious_How_much_do_you_agree_with_the_following_statements                                                                   0.5326
## The_government_should_ensure_racial_equality_by_prohibiting_racial_discrimination_in_private_business_dealings_such_as_hiring_How_much_do_you_agree_with_the_following_statements 0.4105
## Black_people_deserve_reparations_for_the_legacy_of_slavery_How_much_do_you_agree_with_the_following_statements                                                                    0.3864
## I_support_open_borders_How_much_do_you_agree_with_the_following_statements                                                                                                        0.3786
## Politics_suffers_from_white_overrepresentation_How_much_do_you_agree_with_the_following_statements                                                                                0.6758
## Affirmative_action_is_discrimination_How_much_do_you_agree_with_the_following_statements                                                                                          0.3929
## Compared_to_other_civilizations_Western_civilization_is_uniquely_evil_How_much_do_you_agree_with_the_following_statements                                                         0.0617
## Racial_diversity_is_more_important_than_viewpoint_diversity_How_much_do_you_agree_with_the_following_statements                                                                   0.1886
## The_world_is_suffering_from_overpopulation_How_much_do_you_agree_with_the_following_statements                                                                                    0.1441
## I_feel_overwhelmed_or_anxious_by_climate_change_How_much_do_you_agree_with_the_following_statements                                                                               0.4232
## Public_policy_changes_do_not_need_to_be_made_to_deal_with_climate_change_How_much_do_you_agree_with_the_following_statements                                                      0.4486
## Are_you_politically_left_wing_or_right_wing                                                                                                                                       0.5879
## 
## SS loadings:  17.1 
## Proportion Var:  0.417 
## 
## Factor correlations: 
## 
##    F1
## F1  1
#item stats
irt_pol_all_item_stats = get_mirt_stats(irt_pol_all)
irt_pol_all_item_stats$loading %>% abs() %>% describe2()
#scores
irt_pol_all_scores = fscores(irt_pol_all, full.scores = T, full.scores.SE = T)
d$leftism = irt_pol_all_scores[, 1] %>% standardize()

#reliability
empirical_rxx(irt_pol_all_scores)
##    F1 
## 0.968
marginal_rxx(irt_pol_all)
## [1] 0.969
get_reliabilities(irt_pol_all) %>% 
  ggplot(aes(z, rel)) +
  geom_line()

#plot
d %>% 
  GG_denhist("leftism") +
  scale_x_continuous("Leftism (IRT score from 42 items)")
## Scale for x is already present.
## Adding another scale for x, which will replace the existing scale.
## `stat_bin()` using `bins = 30`. Pick better value with `binwidth`.

GG_save("figs/dist leftism.png")
## `stat_bin()` using `bins = 30`. Pick better value with `binwidth`.
#by party
d %>% 
  GG_group_means("leftism", "What_is_your_party_registration")

#gaps in politics by party
SMD_matrix(d$leftism, d$What_is_your_party_registration)
##                  Democrat Independent Other - Write In Republican
## Democrat               NA       0.787            0.490      1.752
## Independent         0.787          NA           -0.297      0.965
## Other - Write In    0.490      -0.297               NA      1.263
## Republican          1.752       0.965            1.263         NA
lm(leftism ~ What_is_your_party_registration, data = d) %>% summary()
## 
## Call:
## lm(formula = leftism ~ What_is_your_party_registration, data = d)
## 
## Residuals:
##     Min      1Q  Median      3Q     Max 
## -3.1505 -0.5510 -0.0014  0.5261  2.7291 
## 
## Coefficients:
##                                                 Estimate Std. Error t value
## (Intercept)                                       0.5750     0.0403   14.26
## What_is_your_party_registrationIndependent       -0.6432     0.0627  -10.25
## What_is_your_party_registrationOther - Write In  -0.4001     0.1828   -2.19
## What_is_your_party_registrationRepublican        -1.4320     0.0650  -22.04
##                                                 Pr(>|t|)    
## (Intercept)                                       <2e-16 ***
## What_is_your_party_registrationIndependent        <2e-16 ***
## What_is_your_party_registrationOther - Write In    0.029 *  
## What_is_your_party_registrationRepublican         <2e-16 ***
## ---
## Signif. codes:  0 '***' 0.001 '**' 0.01 '*' 0.05 '.' 0.1 ' ' 1
## 
## Residual standard error: 0.817 on 974 degrees of freedom
## Multiple R-squared:  0.334,  Adjusted R-squared:  0.332 
## F-statistic:  163 on 3 and 974 DF,  p-value: <2e-16
#by wave
d %>% 
  GG_group_means("leftism", "survey_wave")

#gaps in politics by wave
SMD_matrix(d$leftism, d$survey_wave)
##        wave 1 wave 2
## wave 1     NA  0.224
## wave 2  0.224     NA
#age
d %>% 
  GG_scatter("leftism", "age") + 
  geom_smooth()
## `geom_smooth()` using formula = 'y ~ x'
## `geom_smooth()` using method = 'loess' and formula = 'y ~ x'

GG_save("figs/leftism_age.png")
## `geom_smooth()` using formula = 'y ~ x'
## `geom_smooth()` using method = 'loess' and formula = 'y ~ x'
#sex
d %>% 
  GG_group_means("leftism", "sex")

#gaps in politics
SMD_matrix(d$leftism, d$sex)
##        Female  Male
## Female     NA 0.345
## Male    0.345    NA
#make median split
d$leftism_median_split = d$leftism %>% kirkegaard::discretize(2, equal_range = F, labels = "integer") %>% case_match(1 ~ "Low", 2 ~ "High")
d$leftism_median_split %>% table2()
#with items reversed
pol_vars_num_rev = map2_df(pol_vars_num, 
                          irt_pol_all_item_stats$loading > 0, 
                          function(x, y) {
                            if (y) {
                              x
                            } else {
                              x %>% reverse_scale()
                            }
                          })
                          

#refit
irt_pol_all_rev = mirt(
  pol_vars_num_rev,
  itemtype = pol_vars_options$itemtype,
  model = 1,
  technical = list(NCYCLES = 5000)
)
## Iteration: 1, Log-Lik: -64899.921, Max-Change: 1.96082Iteration: 2, Log-Lik: -63293.792, Max-Change: 0.33245Iteration: 3, Log-Lik: -63042.610, Max-Change: 0.20000Iteration: 4, Log-Lik: -63001.184, Max-Change: 0.18843Iteration: 5, Log-Lik: -62966.150, Max-Change: 0.16475Iteration: 6, Log-Lik: -62943.892, Max-Change: 0.09410Iteration: 7, Log-Lik: -62927.998, Max-Change: 0.09155Iteration: 8, Log-Lik: -62918.087, Max-Change: 0.06230Iteration: 9, Log-Lik: -62909.410, Max-Change: 0.07379Iteration: 10, Log-Lik: -62903.635, Max-Change: 0.03878Iteration: 11, Log-Lik: -62897.856, Max-Change: 0.04867Iteration: 12, Log-Lik: -62894.520, Max-Change: 0.03401Iteration: 13, Log-Lik: -62891.429, Max-Change: 0.04175Iteration: 14, Log-Lik: -62888.600, Max-Change: 0.03112Iteration: 15, Log-Lik: -62886.490, Max-Change: 0.03307Iteration: 16, Log-Lik: -62884.727, Max-Change: 0.03773Iteration: 17, Log-Lik: -62883.350, Max-Change: 0.01951Iteration: 18, Log-Lik: -62881.582, Max-Change: 0.02199Iteration: 19, Log-Lik: -62880.700, Max-Change: 0.01997Iteration: 20, Log-Lik: -62879.436, Max-Change: 0.02703Iteration: 21, Log-Lik: -62878.715, Max-Change: 0.01567Iteration: 22, Log-Lik: -62878.051, Max-Change: 0.01487Iteration: 23, Log-Lik: -62877.274, Max-Change: 0.02088Iteration: 24, Log-Lik: -62876.652, Max-Change: 0.01283Iteration: 25, Log-Lik: -62875.992, Max-Change: 0.01869Iteration: 26, Log-Lik: -62875.566, Max-Change: 0.01075Iteration: 27, Log-Lik: -62875.201, Max-Change: 0.01045Iteration: 28, Log-Lik: -62874.079, Max-Change: 0.00782Iteration: 29, Log-Lik: -62873.933, Max-Change: 0.00719Iteration: 30, Log-Lik: -62873.836, Max-Change: 0.00579Iteration: 31, Log-Lik: -62873.615, Max-Change: 0.00594Iteration: 32, Log-Lik: -62873.543, Max-Change: 0.00494Iteration: 33, Log-Lik: -62873.494, Max-Change: 0.00516Iteration: 34, Log-Lik: -62873.356, Max-Change: 0.00311Iteration: 35, Log-Lik: -62873.327, Max-Change: 0.00183Iteration: 36, Log-Lik: -62873.313, Max-Change: 0.00203Iteration: 37, Log-Lik: -62873.262, Max-Change: 0.00325Iteration: 38, Log-Lik: -62873.249, Max-Change: 0.00141Iteration: 39, Log-Lik: -62873.243, Max-Change: 0.00119Iteration: 40, Log-Lik: -62873.238, Max-Change: 0.00167Iteration: 41, Log-Lik: -62873.237, Max-Change: 0.00204Iteration: 42, Log-Lik: -62873.230, Max-Change: 0.00088Iteration: 43, Log-Lik: -62873.229, Max-Change: 0.00031Iteration: 44, Log-Lik: -62873.229, Max-Change: 0.00042Iteration: 45, Log-Lik: -62873.228, Max-Change: 0.00056Iteration: 46, Log-Lik: -62873.227, Max-Change: 0.00077Iteration: 47, Log-Lik: -62873.226, Max-Change: 0.00103Iteration: 48, Log-Lik: -62873.226, Max-Change: 0.00141Iteration: 49, Log-Lik: -62873.225, Max-Change: 0.00077Iteration: 50, Log-Lik: -62873.224, Max-Change: 0.00105Iteration: 51, Log-Lik: -62873.224, Max-Change: 0.00142Iteration: 52, Log-Lik: -62873.223, Max-Change: 0.00075Iteration: 53, Log-Lik: -62873.222, Max-Change: 0.00101Iteration: 54, Log-Lik: -62873.222, Max-Change: 0.00138Iteration: 55, Log-Lik: -62873.221, Max-Change: 0.00072Iteration: 56, Log-Lik: -62873.221, Max-Change: 0.00099Iteration: 57, Log-Lik: -62873.220, Max-Change: 0.00133Iteration: 58, Log-Lik: -62873.219, Max-Change: 0.00070Iteration: 59, Log-Lik: -62873.219, Max-Change: 0.00094Iteration: 60, Log-Lik: -62873.219, Max-Change: 0.00128Iteration: 61, Log-Lik: -62873.218, Max-Change: 0.00067Iteration: 62, Log-Lik: -62873.217, Max-Change: 0.00092Iteration: 63, Log-Lik: -62873.217, Max-Change: 0.00123Iteration: 64, Log-Lik: -62873.216, Max-Change: 0.00065Iteration: 65, Log-Lik: -62873.216, Max-Change: 0.00087Iteration: 66, Log-Lik: -62873.216, Max-Change: 0.00119Iteration: 67, Log-Lik: -62873.215, Max-Change: 0.00062Iteration: 68, Log-Lik: -62873.215, Max-Change: 0.00085Iteration: 69, Log-Lik: -62873.214, Max-Change: 0.00115Iteration: 70, Log-Lik: -62873.214, Max-Change: 0.00061Iteration: 71, Log-Lik: -62873.214, Max-Change: 0.00081Iteration: 72, Log-Lik: -62873.213, Max-Change: 0.00111Iteration: 73, Log-Lik: -62873.213, Max-Change: 0.00058Iteration: 74, Log-Lik: -62873.212, Max-Change: 0.00080Iteration: 75, Log-Lik: -62873.212, Max-Change: 0.00107Iteration: 76, Log-Lik: -62873.212, Max-Change: 0.00057Iteration: 77, Log-Lik: -62873.211, Max-Change: 0.00076Iteration: 78, Log-Lik: -62873.211, Max-Change: 0.00104Iteration: 79, Log-Lik: -62873.211, Max-Change: 0.00055Iteration: 80, Log-Lik: -62873.210, Max-Change: 0.00075Iteration: 81, Log-Lik: -62873.210, Max-Change: 0.00101Iteration: 82, Log-Lik: -62873.210, Max-Change: 0.00054Iteration: 83, Log-Lik: -62873.209, Max-Change: 0.00072Iteration: 84, Log-Lik: -62873.209, Max-Change: 0.00098Iteration: 85, Log-Lik: -62873.209, Max-Change: 0.00052Iteration: 86, Log-Lik: -62873.208, Max-Change: 0.00071Iteration: 87, Log-Lik: -62873.208, Max-Change: 0.00095Iteration: 88, Log-Lik: -62873.208, Max-Change: 0.00051Iteration: 89, Log-Lik: -62873.208, Max-Change: 0.00068Iteration: 90, Log-Lik: -62873.207, Max-Change: 0.00093Iteration: 91, Log-Lik: -62873.207, Max-Change: 0.00049Iteration: 92, Log-Lik: -62873.207, Max-Change: 0.00068Iteration: 93, Log-Lik: -62873.207, Max-Change: 0.00091Iteration: 94, Log-Lik: -62873.206, Max-Change: 0.00048Iteration: 95, Log-Lik: -62873.206, Max-Change: 0.00065Iteration: 96, Log-Lik: -62873.206, Max-Change: 0.00089Iteration: 97, Log-Lik: -62873.205, Max-Change: 0.00047Iteration: 98, Log-Lik: -62873.205, Max-Change: 0.00064Iteration: 99, Log-Lik: -62873.205, Max-Change: 0.00086Iteration: 100, Log-Lik: -62873.205, Max-Change: 0.00046Iteration: 101, Log-Lik: -62873.205, Max-Change: 0.00062Iteration: 102, Log-Lik: -62873.204, Max-Change: 0.00085Iteration: 103, Log-Lik: -62873.204, Max-Change: 0.00045Iteration: 104, Log-Lik: -62873.204, Max-Change: 0.00062Iteration: 105, Log-Lik: -62873.204, Max-Change: 0.00083Iteration: 106, Log-Lik: -62873.203, Max-Change: 0.00045Iteration: 107, Log-Lik: -62873.203, Max-Change: 0.00060Iteration: 108, Log-Lik: -62873.203, Max-Change: 0.00082Iteration: 109, Log-Lik: -62873.203, Max-Change: 0.00043Iteration: 110, Log-Lik: -62873.203, Max-Change: 0.00059Iteration: 111, Log-Lik: -62873.202, Max-Change: 0.00080Iteration: 112, Log-Lik: -62873.202, Max-Change: 0.00043Iteration: 113, Log-Lik: -62873.202, Max-Change: 0.00057Iteration: 114, Log-Lik: -62873.202, Max-Change: 0.00079Iteration: 115, Log-Lik: -62873.202, Max-Change: 0.00042Iteration: 116, Log-Lik: -62873.201, Max-Change: 0.00057Iteration: 117, Log-Lik: -62873.201, Max-Change: 0.00077Iteration: 118, Log-Lik: -62873.201, Max-Change: 0.00042Iteration: 119, Log-Lik: -62873.201, Max-Change: 0.00056Iteration: 120, Log-Lik: -62873.201, Max-Change: 0.00076Iteration: 121, Log-Lik: -62873.200, Max-Change: 0.00040Iteration: 122, Log-Lik: -62873.200, Max-Change: 0.00056Iteration: 123, Log-Lik: -62873.200, Max-Change: 0.00075Iteration: 124, Log-Lik: -62873.200, Max-Change: 0.00040Iteration: 125, Log-Lik: -62873.200, Max-Change: 0.00054Iteration: 126, Log-Lik: -62873.200, Max-Change: 0.00074Iteration: 127, Log-Lik: -62873.199, Max-Change: 0.00039Iteration: 128, Log-Lik: -62873.199, Max-Change: 0.00054Iteration: 129, Log-Lik: -62873.199, Max-Change: 0.00072Iteration: 130, Log-Lik: -62873.199, Max-Change: 0.00039Iteration: 131, Log-Lik: -62873.199, Max-Change: 0.00052Iteration: 132, Log-Lik: -62873.198, Max-Change: 0.00072Iteration: 133, Log-Lik: -62873.198, Max-Change: 0.00038Iteration: 134, Log-Lik: -62873.198, Max-Change: 0.00053Iteration: 135, Log-Lik: -62873.198, Max-Change: 0.00071Iteration: 136, Log-Lik: -62873.198, Max-Change: 0.00038Iteration: 137, Log-Lik: -62873.198, Max-Change: 0.00051Iteration: 138, Log-Lik: -62873.197, Max-Change: 0.00070Iteration: 139, Log-Lik: -62873.197, Max-Change: 0.00037Iteration: 140, Log-Lik: -62873.197, Max-Change: 0.00051Iteration: 141, Log-Lik: -62873.197, Max-Change: 0.00069Iteration: 142, Log-Lik: -62873.197, Max-Change: 0.00037Iteration: 143, Log-Lik: -62873.197, Max-Change: 0.00050Iteration: 144, Log-Lik: -62873.197, Max-Change: 0.00069Iteration: 145, Log-Lik: -62873.196, Max-Change: 0.00037Iteration: 146, Log-Lik: -62873.196, Max-Change: 0.00050Iteration: 147, Log-Lik: -62873.196, Max-Change: 0.00067Iteration: 148, Log-Lik: -62873.196, Max-Change: 0.00037Iteration: 149, Log-Lik: -62873.196, Max-Change: 0.00049Iteration: 150, Log-Lik: -62873.196, Max-Change: 0.00067Iteration: 151, Log-Lik: -62873.195, Max-Change: 0.00036Iteration: 152, Log-Lik: -62873.195, Max-Change: 0.00049Iteration: 153, Log-Lik: -62873.195, Max-Change: 0.00066Iteration: 154, Log-Lik: -62873.195, Max-Change: 0.00036Iteration: 155, Log-Lik: -62873.195, Max-Change: 0.00048Iteration: 156, Log-Lik: -62873.195, Max-Change: 0.00066Iteration: 157, Log-Lik: -62873.195, Max-Change: 0.00035Iteration: 158, Log-Lik: -62873.194, Max-Change: 0.00048Iteration: 159, Log-Lik: -62873.194, Max-Change: 0.00065Iteration: 160, Log-Lik: -62873.194, Max-Change: 0.00035Iteration: 161, Log-Lik: -62873.194, Max-Change: 0.00047Iteration: 162, Log-Lik: -62873.194, Max-Change: 0.00065Iteration: 163, Log-Lik: -62873.194, Max-Change: 0.00035Iteration: 164, Log-Lik: -62873.194, Max-Change: 0.00048Iteration: 165, Log-Lik: -62873.193, Max-Change: 0.00064Iteration: 166, Log-Lik: -62873.193, Max-Change: 0.00035Iteration: 167, Log-Lik: -62873.193, Max-Change: 0.00046Iteration: 168, Log-Lik: -62873.193, Max-Change: 0.00064Iteration: 169, Log-Lik: -62873.193, Max-Change: 0.00034Iteration: 170, Log-Lik: -62873.193, Max-Change: 0.00047Iteration: 171, Log-Lik: -62873.193, Max-Change: 0.00063Iteration: 172, Log-Lik: -62873.193, Max-Change: 0.00034Iteration: 173, Log-Lik: -62873.192, Max-Change: 0.00046Iteration: 174, Log-Lik: -62873.192, Max-Change: 0.00063Iteration: 175, Log-Lik: -62873.192, Max-Change: 0.00033Iteration: 176, Log-Lik: -62873.192, Max-Change: 0.00046Iteration: 177, Log-Lik: -62873.192, Max-Change: 0.00062Iteration: 178, Log-Lik: -62873.192, Max-Change: 0.00034Iteration: 179, Log-Lik: -62873.192, Max-Change: 0.00045Iteration: 180, Log-Lik: -62873.192, Max-Change: 0.00062Iteration: 181, Log-Lik: -62873.191, Max-Change: 0.00033Iteration: 182, Log-Lik: -62873.191, Max-Change: 0.00045Iteration: 183, Log-Lik: -62873.191, Max-Change: 0.00061Iteration: 184, Log-Lik: -62873.191, Max-Change: 0.00033Iteration: 185, Log-Lik: -62873.191, Max-Change: 0.00044Iteration: 186, Log-Lik: -62873.191, Max-Change: 0.00061Iteration: 187, Log-Lik: -62873.191, Max-Change: 0.00032Iteration: 188, Log-Lik: -62873.190, Max-Change: 0.00045Iteration: 189, Log-Lik: -62873.190, Max-Change: 0.00060Iteration: 190, Log-Lik: -62873.190, Max-Change: 0.00033Iteration: 191, Log-Lik: -62873.190, Max-Change: 0.00044Iteration: 192, Log-Lik: -62873.190, Max-Change: 0.00060Iteration: 193, Log-Lik: -62873.190, Max-Change: 0.00032Iteration: 194, Log-Lik: -62873.190, Max-Change: 0.00044Iteration: 195, Log-Lik: -62873.190, Max-Change: 0.00059Iteration: 196, Log-Lik: -62873.190, Max-Change: 0.00032Iteration: 197, Log-Lik: -62873.189, Max-Change: 0.00043Iteration: 198, Log-Lik: -62873.189, Max-Change: 0.00059Iteration: 199, Log-Lik: -62873.189, Max-Change: 0.00032Iteration: 200, Log-Lik: -62873.189, Max-Change: 0.00044Iteration: 201, Log-Lik: -62873.189, Max-Change: 0.00058Iteration: 202, Log-Lik: -62873.189, Max-Change: 0.00032Iteration: 203, Log-Lik: -62873.189, Max-Change: 0.00042Iteration: 204, Log-Lik: -62873.189, Max-Change: 0.00058Iteration: 205, Log-Lik: -62873.189, Max-Change: 0.00031Iteration: 206, Log-Lik: -62873.188, Max-Change: 0.00043Iteration: 207, Log-Lik: -62873.188, Max-Change: 0.00058Iteration: 208, Log-Lik: -62873.188, Max-Change: 0.00031Iteration: 209, Log-Lik: -62873.188, Max-Change: 0.00042Iteration: 210, Log-Lik: -62873.188, Max-Change: 0.00058Iteration: 211, Log-Lik: -62873.188, Max-Change: 0.00031Iteration: 212, Log-Lik: -62873.188, Max-Change: 0.00042Iteration: 213, Log-Lik: -62873.188, Max-Change: 0.00057Iteration: 214, Log-Lik: -62873.188, Max-Change: 0.00031Iteration: 215, Log-Lik: -62873.187, Max-Change: 0.00041Iteration: 216, Log-Lik: -62873.187, Max-Change: 0.00057Iteration: 217, Log-Lik: -62873.187, Max-Change: 0.00030Iteration: 218, Log-Lik: -62873.187, Max-Change: 0.00042Iteration: 219, Log-Lik: -62873.187, Max-Change: 0.00056Iteration: 220, Log-Lik: -62873.187, Max-Change: 0.00031Iteration: 221, Log-Lik: -62873.187, Max-Change: 0.00041Iteration: 222, Log-Lik: -62873.187, Max-Change: 0.00056Iteration: 223, Log-Lik: -62873.187, Max-Change: 0.00030Iteration: 224, Log-Lik: -62873.186, Max-Change: 0.00041Iteration: 225, Log-Lik: -62873.186, Max-Change: 0.00055Iteration: 226, Log-Lik: -62873.186, Max-Change: 0.00030Iteration: 227, Log-Lik: -62873.186, Max-Change: 0.00040Iteration: 228, Log-Lik: -62873.186, Max-Change: 0.00056Iteration: 229, Log-Lik: -62873.186, Max-Change: 0.00030Iteration: 230, Log-Lik: -62873.186, Max-Change: 0.00041Iteration: 231, Log-Lik: -62873.186, Max-Change: 0.00055Iteration: 232, Log-Lik: -62873.186, Max-Change: 0.00030Iteration: 233, Log-Lik: -62873.186, Max-Change: 0.00040Iteration: 234, Log-Lik: -62873.185, Max-Change: 0.00055Iteration: 235, Log-Lik: -62873.185, Max-Change: 0.00029Iteration: 236, Log-Lik: -62873.185, Max-Change: 0.00040Iteration: 237, Log-Lik: -62873.185, Max-Change: 0.00054Iteration: 238, Log-Lik: -62873.185, Max-Change: 0.00030Iteration: 239, Log-Lik: -62873.185, Max-Change: 0.00040Iteration: 240, Log-Lik: -62873.185, Max-Change: 0.00054Iteration: 241, Log-Lik: -62873.185, Max-Change: 0.00029Iteration: 242, Log-Lik: -62873.185, Max-Change: 0.00040Iteration: 243, Log-Lik: -62873.185, Max-Change: 0.00054Iteration: 244, Log-Lik: -62873.184, Max-Change: 0.00029Iteration: 245, Log-Lik: -62873.184, Max-Change: 0.00039Iteration: 246, Log-Lik: -62873.184, Max-Change: 0.00054Iteration: 247, Log-Lik: -62873.184, Max-Change: 0.00029Iteration: 248, Log-Lik: -62873.184, Max-Change: 0.00040Iteration: 249, Log-Lik: -62873.184, Max-Change: 0.00053Iteration: 250, Log-Lik: -62873.184, Max-Change: 0.00029Iteration: 251, Log-Lik: -62873.184, Max-Change: 0.00039Iteration: 252, Log-Lik: -62873.184, Max-Change: 0.00053Iteration: 253, Log-Lik: -62873.184, Max-Change: 0.00028Iteration: 254, Log-Lik: -62873.184, Max-Change: 0.00039Iteration: 255, Log-Lik: -62873.183, Max-Change: 0.00052Iteration: 256, Log-Lik: -62873.183, Max-Change: 0.00029Iteration: 257, Log-Lik: -62873.183, Max-Change: 0.00038Iteration: 258, Log-Lik: -62873.183, Max-Change: 0.00052Iteration: 259, Log-Lik: -62873.183, Max-Change: 0.00028Iteration: 260, Log-Lik: -62873.183, Max-Change: 0.00039Iteration: 261, Log-Lik: -62873.183, Max-Change: 0.00052Iteration: 262, Log-Lik: -62873.183, Max-Change: 0.00028Iteration: 263, Log-Lik: -62873.183, Max-Change: 0.00038Iteration: 264, Log-Lik: -62873.183, Max-Change: 0.00052Iteration: 265, Log-Lik: -62873.182, Max-Change: 0.00028Iteration: 266, Log-Lik: -62873.182, Max-Change: 0.00038Iteration: 267, Log-Lik: -62873.182, Max-Change: 0.00051Iteration: 268, Log-Lik: -62873.182, Max-Change: 0.00028Iteration: 269, Log-Lik: -62873.182, Max-Change: 0.00037Iteration: 270, Log-Lik: -62873.182, Max-Change: 0.00051Iteration: 271, Log-Lik: -62873.182, Max-Change: 0.00027Iteration: 272, Log-Lik: -62873.182, Max-Change: 0.00038Iteration: 273, Log-Lik: -62873.182, Max-Change: 0.00051Iteration: 274, Log-Lik: -62873.182, Max-Change: 0.00028Iteration: 275, Log-Lik: -62873.182, Max-Change: 0.00037Iteration: 276, Log-Lik: -62873.182, Max-Change: 0.00051Iteration: 277, Log-Lik: -62873.181, Max-Change: 0.00027Iteration: 278, Log-Lik: -62873.181, Max-Change: 0.00037Iteration: 279, Log-Lik: -62873.181, Max-Change: 0.00050Iteration: 280, Log-Lik: -62873.181, Max-Change: 0.00027Iteration: 281, Log-Lik: -62873.181, Max-Change: 0.00037Iteration: 282, Log-Lik: -62873.181, Max-Change: 0.00050Iteration: 283, Log-Lik: -62873.181, Max-Change: 0.00027Iteration: 284, Log-Lik: -62873.181, Max-Change: 0.00037Iteration: 285, Log-Lik: -62873.181, Max-Change: 0.00050Iteration: 286, Log-Lik: -62873.181, Max-Change: 0.00027Iteration: 287, Log-Lik: -62873.181, Max-Change: 0.00036Iteration: 288, Log-Lik: -62873.181, Max-Change: 0.00050Iteration: 289, Log-Lik: -62873.180, Max-Change: 0.00027Iteration: 290, Log-Lik: -62873.180, Max-Change: 0.00037Iteration: 291, Log-Lik: -62873.180, Max-Change: 0.00049Iteration: 292, Log-Lik: -62873.180, Max-Change: 0.00027Iteration: 293, Log-Lik: -62873.180, Max-Change: 0.00036Iteration: 294, Log-Lik: -62873.180, Max-Change: 0.00049Iteration: 295, Log-Lik: -62873.180, Max-Change: 0.00026Iteration: 296, Log-Lik: -62873.180, Max-Change: 0.00036Iteration: 297, Log-Lik: -62873.180, Max-Change: 0.00048Iteration: 298, Log-Lik: -62873.180, Max-Change: 0.00027Iteration: 299, Log-Lik: -62873.180, Max-Change: 0.00035Iteration: 300, Log-Lik: -62873.180, Max-Change: 0.00049Iteration: 301, Log-Lik: -62873.179, Max-Change: 0.00026Iteration: 302, Log-Lik: -62873.179, Max-Change: 0.00036Iteration: 303, Log-Lik: -62873.179, Max-Change: 0.00048Iteration: 304, Log-Lik: -62873.179, Max-Change: 0.00026Iteration: 305, Log-Lik: -62873.179, Max-Change: 0.00035Iteration: 306, Log-Lik: -62873.179, Max-Change: 0.00048Iteration: 307, Log-Lik: -62873.179, Max-Change: 0.00026Iteration: 308, Log-Lik: -62873.179, Max-Change: 0.00035Iteration: 309, Log-Lik: -62873.179, Max-Change: 0.00047Iteration: 310, Log-Lik: -62873.179, Max-Change: 0.00026Iteration: 311, Log-Lik: -62873.179, Max-Change: 0.00035Iteration: 312, Log-Lik: -62873.179, Max-Change: 0.00048Iteration: 313, Log-Lik: -62873.179, Max-Change: 0.00025Iteration: 314, Log-Lik: -62873.178, Max-Change: 0.00035Iteration: 315, Log-Lik: -62873.178, Max-Change: 0.00047Iteration: 316, Log-Lik: -62873.178, Max-Change: 0.00026Iteration: 317, Log-Lik: -62873.178, Max-Change: 0.00034Iteration: 318, Log-Lik: -62873.178, Max-Change: 0.00047Iteration: 319, Log-Lik: -62873.178, Max-Change: 0.00025Iteration: 320, Log-Lik: -62873.178, Max-Change: 0.00035Iteration: 321, Log-Lik: -62873.178, Max-Change: 0.00046Iteration: 322, Log-Lik: -62873.178, Max-Change: 0.00025Iteration: 323, Log-Lik: -62873.178, Max-Change: 0.00034Iteration: 324, Log-Lik: -62873.178, Max-Change: 0.00047Iteration: 325, Log-Lik: -62873.178, Max-Change: 0.00025Iteration: 326, Log-Lik: -62873.178, Max-Change: 0.00034Iteration: 327, Log-Lik: -62873.178, Max-Change: 0.00046Iteration: 328, Log-Lik: -62873.177, Max-Change: 0.00025Iteration: 329, Log-Lik: -62873.177, Max-Change: 0.00034Iteration: 330, Log-Lik: -62873.177, Max-Change: 0.00046Iteration: 331, Log-Lik: -62873.177, Max-Change: 0.00025Iteration: 332, Log-Lik: -62873.177, Max-Change: 0.00034Iteration: 333, Log-Lik: -62873.177, Max-Change: 0.00045Iteration: 334, Log-Lik: -62873.177, Max-Change: 0.00025Iteration: 335, Log-Lik: -62873.177, Max-Change: 0.00033Iteration: 336, Log-Lik: -62873.177, Max-Change: 0.00046Iteration: 337, Log-Lik: -62873.177, Max-Change: 0.00024Iteration: 338, Log-Lik: -62873.177, Max-Change: 0.00034Iteration: 339, Log-Lik: -62873.177, Max-Change: 0.00045Iteration: 340, Log-Lik: -62873.177, Max-Change: 0.00025Iteration: 341, Log-Lik: -62873.177, Max-Change: 0.00033Iteration: 342, Log-Lik: -62873.177, Max-Change: 0.00045Iteration: 343, Log-Lik: -62873.176, Max-Change: 0.00024Iteration: 344, Log-Lik: -62873.176, Max-Change: 0.00033Iteration: 345, Log-Lik: -62873.176, Max-Change: 0.00044Iteration: 346, Log-Lik: -62873.176, Max-Change: 0.00024Iteration: 347, Log-Lik: -62873.176, Max-Change: 0.00033Iteration: 348, Log-Lik: -62873.176, Max-Change: 0.00045Iteration: 349, Log-Lik: -62873.176, Max-Change: 0.00024Iteration: 350, Log-Lik: -62873.176, Max-Change: 0.00033Iteration: 351, Log-Lik: -62873.176, Max-Change: 0.00044Iteration: 352, Log-Lik: -62873.176, Max-Change: 0.00024Iteration: 353, Log-Lik: -62873.176, Max-Change: 0.00032Iteration: 354, Log-Lik: -62873.176, Max-Change: 0.00044Iteration: 355, Log-Lik: -62873.176, Max-Change: 0.00024Iteration: 356, Log-Lik: -62873.176, Max-Change: 0.00033Iteration: 357, Log-Lik: -62873.176, Max-Change: 0.00044Iteration: 358, Log-Lik: -62873.175, Max-Change: 0.00024Iteration: 359, Log-Lik: -62873.175, Max-Change: 0.00032Iteration: 360, Log-Lik: -62873.175, Max-Change: 0.00044Iteration: 361, Log-Lik: -62873.175, Max-Change: 0.00023Iteration: 362, Log-Lik: -62873.175, Max-Change: 0.00032Iteration: 363, Log-Lik: -62873.175, Max-Change: 0.00043Iteration: 364, Log-Lik: -62873.175, Max-Change: 0.00024Iteration: 365, Log-Lik: -62873.175, Max-Change: 0.00031Iteration: 366, Log-Lik: -62873.175, Max-Change: 0.00043Iteration: 367, Log-Lik: -62873.175, Max-Change: 0.00023Iteration: 368, Log-Lik: -62873.175, Max-Change: 0.00032Iteration: 369, Log-Lik: -62873.175, Max-Change: 0.00043Iteration: 370, Log-Lik: -62873.175, Max-Change: 0.00023Iteration: 371, Log-Lik: -62873.175, Max-Change: 0.00031Iteration: 372, Log-Lik: -62873.175, Max-Change: 0.00043Iteration: 373, Log-Lik: -62873.175, Max-Change: 0.00023Iteration: 374, Log-Lik: -62873.174, Max-Change: 0.00031Iteration: 375, Log-Lik: -62873.174, Max-Change: 0.00042Iteration: 376, Log-Lik: -62873.174, Max-Change: 0.00023Iteration: 377, Log-Lik: -62873.174, Max-Change: 0.00031Iteration: 378, Log-Lik: -62873.174, Max-Change: 0.00042Iteration: 379, Log-Lik: -62873.174, Max-Change: 0.00023Iteration: 380, Log-Lik: -62873.174, Max-Change: 0.00031Iteration: 381, Log-Lik: -62873.174, Max-Change: 0.00042Iteration: 382, Log-Lik: -62873.174, Max-Change: 0.00023Iteration: 383, Log-Lik: -62873.174, Max-Change: 0.00030Iteration: 384, Log-Lik: -62873.174, Max-Change: 0.00042Iteration: 385, Log-Lik: -62873.174, Max-Change: 0.00022Iteration: 386, Log-Lik: -62873.174, Max-Change: 0.00031Iteration: 387, Log-Lik: -62873.174, Max-Change: 0.00041Iteration: 388, Log-Lik: -62873.174, Max-Change: 0.00023Iteration: 389, Log-Lik: -62873.174, Max-Change: 0.00030Iteration: 390, Log-Lik: -62873.174, Max-Change: 0.00041Iteration: 391, Log-Lik: -62873.173, Max-Change: 0.00022Iteration: 392, Log-Lik: -62873.173, Max-Change: 0.00031Iteration: 393, Log-Lik: -62873.173, Max-Change: 0.00041Iteration: 394, Log-Lik: -62873.173, Max-Change: 0.00022Iteration: 395, Log-Lik: -62873.173, Max-Change: 0.00030Iteration: 396, Log-Lik: -62873.173, Max-Change: 0.00041Iteration: 397, Log-Lik: -62873.173, Max-Change: 0.00022Iteration: 398, Log-Lik: -62873.173, Max-Change: 0.00030Iteration: 399, Log-Lik: -62873.173, Max-Change: 0.00040Iteration: 400, Log-Lik: -62873.173, Max-Change: 0.00022Iteration: 401, Log-Lik: -62873.173, Max-Change: 0.00030Iteration: 402, Log-Lik: -62873.173, Max-Change: 0.00041Iteration: 403, Log-Lik: -62873.173, Max-Change: 0.00022Iteration: 404, Log-Lik: -62873.173, Max-Change: 0.00030Iteration: 405, Log-Lik: -62873.173, Max-Change: 0.00040Iteration: 406, Log-Lik: -62873.173, Max-Change: 0.00022Iteration: 407, Log-Lik: -62873.173, Max-Change: 0.00029Iteration: 408, Log-Lik: -62873.173, Max-Change: 0.00040Iteration: 409, Log-Lik: -62873.172, Max-Change: 0.00021Iteration: 410, Log-Lik: -62873.172, Max-Change: 0.00030Iteration: 411, Log-Lik: -62873.172, Max-Change: 0.00040Iteration: 412, Log-Lik: -62873.172, Max-Change: 0.00022Iteration: 413, Log-Lik: -62873.172, Max-Change: 0.00029Iteration: 414, Log-Lik: -62873.172, Max-Change: 0.00040Iteration: 415, Log-Lik: -62873.172, Max-Change: 0.00021Iteration: 416, Log-Lik: -62873.172, Max-Change: 0.00029Iteration: 417, Log-Lik: -62873.172, Max-Change: 0.00039Iteration: 418, Log-Lik: -62873.172, Max-Change: 0.00021Iteration: 419, Log-Lik: -62873.172, Max-Change: 0.00029Iteration: 420, Log-Lik: -62873.172, Max-Change: 0.00039Iteration: 421, Log-Lik: -62873.172, Max-Change: 0.00021Iteration: 422, Log-Lik: -62873.172, Max-Change: 0.00029Iteration: 423, Log-Lik: -62873.172, Max-Change: 0.00039Iteration: 424, Log-Lik: -62873.172, Max-Change: 0.00021Iteration: 425, Log-Lik: -62873.172, Max-Change: 0.00028Iteration: 426, Log-Lik: -62873.172, Max-Change: 0.00039Iteration: 427, Log-Lik: -62873.172, Max-Change: 0.00021Iteration: 428, Log-Lik: -62873.171, Max-Change: 0.00029Iteration: 429, Log-Lik: -62873.171, Max-Change: 0.00038Iteration: 430, Log-Lik: -62873.171, Max-Change: 0.00021Iteration: 431, Log-Lik: -62873.171, Max-Change: 0.00028Iteration: 432, Log-Lik: -62873.171, Max-Change: 0.00038Iteration: 433, Log-Lik: -62873.171, Max-Change: 0.00021Iteration: 434, Log-Lik: -62873.171, Max-Change: 0.00028Iteration: 435, Log-Lik: -62873.171, Max-Change: 0.00038Iteration: 436, Log-Lik: -62873.171, Max-Change: 0.00021Iteration: 437, Log-Lik: -62873.171, Max-Change: 0.00028Iteration: 438, Log-Lik: -62873.171, Max-Change: 0.00038Iteration: 439, Log-Lik: -62873.171, Max-Change: 0.00020Iteration: 440, Log-Lik: -62873.171, Max-Change: 0.00028Iteration: 441, Log-Lik: -62873.171, Max-Change: 0.00037Iteration: 442, Log-Lik: -62873.171, Max-Change: 0.00021Iteration: 443, Log-Lik: -62873.171, Max-Change: 0.00027Iteration: 444, Log-Lik: -62873.171, Max-Change: 0.00038Iteration: 445, Log-Lik: -62873.171, Max-Change: 0.00020Iteration: 446, Log-Lik: -62873.171, Max-Change: 0.00028Iteration: 447, Log-Lik: -62873.171, Max-Change: 0.00037Iteration: 448, Log-Lik: -62873.171, Max-Change: 0.00020Iteration: 449, Log-Lik: -62873.170, Max-Change: 0.00027Iteration: 450, Log-Lik: -62873.170, Max-Change: 0.00037Iteration: 451, Log-Lik: -62873.170, Max-Change: 0.00020Iteration: 452, Log-Lik: -62873.170, Max-Change: 0.00027Iteration: 453, Log-Lik: -62873.170, Max-Change: 0.00037Iteration: 454, Log-Lik: -62873.170, Max-Change: 0.00020Iteration: 455, Log-Lik: -62873.170, Max-Change: 0.00027Iteration: 456, Log-Lik: -62873.170, Max-Change: 0.00037Iteration: 457, Log-Lik: -62873.170, Max-Change: 0.00020Iteration: 458, Log-Lik: -62873.170, Max-Change: 0.00027Iteration: 459, Log-Lik: -62873.170, Max-Change: 0.00036Iteration: 460, Log-Lik: -62873.170, Max-Change: 0.00020Iteration: 461, Log-Lik: -62873.170, Max-Change: 0.00027Iteration: 462, Log-Lik: -62873.170, Max-Change: 0.00036Iteration: 463, Log-Lik: -62873.170, Max-Change: 0.00019Iteration: 464, Log-Lik: -62873.170, Max-Change: 0.00027Iteration: 465, Log-Lik: -62873.170, Max-Change: 0.00036Iteration: 466, Log-Lik: -62873.170, Max-Change: 0.00020Iteration: 467, Log-Lik: -62873.170, Max-Change: 0.00026Iteration: 468, Log-Lik: -62873.170, Max-Change: 0.00036Iteration: 469, Log-Lik: -62873.170, Max-Change: 0.00019Iteration: 470, Log-Lik: -62873.170, Max-Change: 0.00027Iteration: 471, Log-Lik: -62873.170, Max-Change: 0.00036Iteration: 472, Log-Lik: -62873.169, Max-Change: 0.00019Iteration: 473, Log-Lik: -62873.169, Max-Change: 0.00026Iteration: 474, Log-Lik: -62873.169, Max-Change: 0.00036Iteration: 475, Log-Lik: -62873.169, Max-Change: 0.00019Iteration: 476, Log-Lik: -62873.169, Max-Change: 0.00026Iteration: 477, Log-Lik: -62873.169, Max-Change: 0.00035Iteration: 478, Log-Lik: -62873.169, Max-Change: 0.00019Iteration: 479, Log-Lik: -62873.169, Max-Change: 0.00026Iteration: 480, Log-Lik: -62873.169, Max-Change: 0.00035Iteration: 481, Log-Lik: -62873.169, Max-Change: 0.00019Iteration: 482, Log-Lik: -62873.169, Max-Change: 0.00026Iteration: 483, Log-Lik: -62873.169, Max-Change: 0.00035Iteration: 484, Log-Lik: -62873.169, Max-Change: 0.00019Iteration: 485, Log-Lik: -62873.169, Max-Change: 0.00025Iteration: 486, Log-Lik: -62873.169, Max-Change: 0.00035Iteration: 487, Log-Lik: -62873.169, Max-Change: 0.00019Iteration: 488, Log-Lik: -62873.169, Max-Change: 0.00026Iteration: 489, Log-Lik: -62873.169, Max-Change: 0.00034Iteration: 490, Log-Lik: -62873.169, Max-Change: 0.00019Iteration: 491, Log-Lik: -62873.169, Max-Change: 0.00025Iteration: 492, Log-Lik: -62873.169, Max-Change: 0.00035Iteration: 493, Log-Lik: -62873.169, Max-Change: 0.00018Iteration: 494, Log-Lik: -62873.169, Max-Change: 0.00025Iteration: 495, Log-Lik: -62873.169, Max-Change: 0.00034Iteration: 496, Log-Lik: -62873.168, Max-Change: 0.00019Iteration: 497, Log-Lik: -62873.168, Max-Change: 0.00025Iteration: 498, Log-Lik: -62873.168, Max-Change: 0.00034Iteration: 499, Log-Lik: -62873.168, Max-Change: 0.00018Iteration: 500, Log-Lik: -62873.168, Max-Change: 0.00025Iteration: 501, Log-Lik: -62873.168, Max-Change: 0.00034Iteration: 502, Log-Lik: -62873.168, Max-Change: 0.00018Iteration: 503, Log-Lik: -62873.168, Max-Change: 0.00025Iteration: 504, Log-Lik: -62873.168, Max-Change: 0.00034Iteration: 505, Log-Lik: -62873.168, Max-Change: 0.00018Iteration: 506, Log-Lik: -62873.168, Max-Change: 0.00025Iteration: 507, Log-Lik: -62873.168, Max-Change: 0.00033Iteration: 508, Log-Lik: -62873.168, Max-Change: 0.00018Iteration: 509, Log-Lik: -62873.168, Max-Change: 0.00024Iteration: 510, Log-Lik: -62873.168, Max-Change: 0.00033Iteration: 511, Log-Lik: -62873.168, Max-Change: 0.00018Iteration: 512, Log-Lik: -62873.168, Max-Change: 0.00025Iteration: 513, Log-Lik: -62873.168, Max-Change: 0.00033Iteration: 514, Log-Lik: -62873.168, Max-Change: 0.00018Iteration: 515, Log-Lik: -62873.168, Max-Change: 0.00024Iteration: 516, Log-Lik: -62873.168, Max-Change: 0.00033Iteration: 517, Log-Lik: -62873.168, Max-Change: 0.00018Iteration: 518, Log-Lik: -62873.168, Max-Change: 0.00024Iteration: 519, Log-Lik: -62873.168, Max-Change: 0.00033Iteration: 520, Log-Lik: -62873.168, Max-Change: 0.00018Iteration: 521, Log-Lik: -62873.168, Max-Change: 0.00024Iteration: 522, Log-Lik: -62873.168, Max-Change: 0.00033Iteration: 523, Log-Lik: -62873.167, Max-Change: 0.00018Iteration: 524, Log-Lik: -62873.167, Max-Change: 0.00024Iteration: 525, Log-Lik: -62873.167, Max-Change: 0.00032Iteration: 526, Log-Lik: -62873.167, Max-Change: 0.00018Iteration: 527, Log-Lik: -62873.167, Max-Change: 0.00024Iteration: 528, Log-Lik: -62873.167, Max-Change: 0.00032Iteration: 529, Log-Lik: -62873.167, Max-Change: 0.00017Iteration: 530, Log-Lik: -62873.167, Max-Change: 0.00024Iteration: 531, Log-Lik: -62873.167, Max-Change: 0.00032Iteration: 532, Log-Lik: -62873.167, Max-Change: 0.00018Iteration: 533, Log-Lik: -62873.167, Max-Change: 0.00023Iteration: 534, Log-Lik: -62873.167, Max-Change: 0.00032Iteration: 535, Log-Lik: -62873.167, Max-Change: 0.00017Iteration: 536, Log-Lik: -62873.167, Max-Change: 0.00024Iteration: 537, Log-Lik: -62873.167, Max-Change: 0.00032Iteration: 538, Log-Lik: -62873.167, Max-Change: 0.00017Iteration: 539, Log-Lik: -62873.167, Max-Change: 0.00023Iteration: 540, Log-Lik: -62873.167, Max-Change: 0.00032Iteration: 541, Log-Lik: -62873.167, Max-Change: 0.00017Iteration: 542, Log-Lik: -62873.167, Max-Change: 0.00023Iteration: 543, Log-Lik: -62873.167, Max-Change: 0.00031Iteration: 544, Log-Lik: -62873.167, Max-Change: 0.00017Iteration: 545, Log-Lik: -62873.167, Max-Change: 0.00023Iteration: 546, Log-Lik: -62873.167, Max-Change: 0.00031Iteration: 547, Log-Lik: -62873.167, Max-Change: 0.00017Iteration: 548, Log-Lik: -62873.167, Max-Change: 0.00023Iteration: 549, Log-Lik: -62873.167, Max-Change: 0.00031Iteration: 550, Log-Lik: -62873.167, Max-Change: 0.00017Iteration: 551, Log-Lik: -62873.167, Max-Change: 0.00023Iteration: 552, Log-Lik: -62873.167, Max-Change: 0.00031Iteration: 553, Log-Lik: -62873.166, Max-Change: 0.00017Iteration: 554, Log-Lik: -62873.166, Max-Change: 0.00023Iteration: 555, Log-Lik: -62873.166, Max-Change: 0.00031Iteration: 556, Log-Lik: -62873.166, Max-Change: 0.00017Iteration: 557, Log-Lik: -62873.166, Max-Change: 0.00022Iteration: 558, Log-Lik: -62873.166, Max-Change: 0.00031Iteration: 559, Log-Lik: -62873.166, Max-Change: 0.00016Iteration: 560, Log-Lik: -62873.166, Max-Change: 0.00023Iteration: 561, Log-Lik: -62873.166, Max-Change: 0.00030Iteration: 562, Log-Lik: -62873.166, Max-Change: 0.00017Iteration: 563, Log-Lik: -62873.166, Max-Change: 0.00022Iteration: 564, Log-Lik: -62873.166, Max-Change: 0.00030Iteration: 565, Log-Lik: -62873.166, Max-Change: 0.00016Iteration: 566, Log-Lik: -62873.166, Max-Change: 0.00022Iteration: 567, Log-Lik: -62873.166, Max-Change: 0.00030Iteration: 568, Log-Lik: -62873.166, Max-Change: 0.00016Iteration: 569, Log-Lik: -62873.166, Max-Change: 0.00022Iteration: 570, Log-Lik: -62873.166, Max-Change: 0.00030Iteration: 571, Log-Lik: -62873.166, Max-Change: 0.00016Iteration: 572, Log-Lik: -62873.166, Max-Change: 0.00022Iteration: 573, Log-Lik: -62873.166, Max-Change: 0.00030Iteration: 574, Log-Lik: -62873.166, Max-Change: 0.00016Iteration: 575, Log-Lik: -62873.166, Max-Change: 0.00022Iteration: 576, Log-Lik: -62873.166, Max-Change: 0.00030Iteration: 577, Log-Lik: -62873.166, Max-Change: 0.00016Iteration: 578, Log-Lik: -62873.166, Max-Change: 0.00022Iteration: 579, Log-Lik: -62873.166, Max-Change: 0.00029Iteration: 580, Log-Lik: -62873.166, Max-Change: 0.00016Iteration: 581, Log-Lik: -62873.166, Max-Change: 0.00021Iteration: 582, Log-Lik: -62873.166, Max-Change: 0.00029Iteration: 583, Log-Lik: -62873.166, Max-Change: 0.00016Iteration: 584, Log-Lik: -62873.166, Max-Change: 0.00022Iteration: 585, Log-Lik: -62873.166, Max-Change: 0.00029Iteration: 586, Log-Lik: -62873.165, Max-Change: 0.00016Iteration: 587, Log-Lik: -62873.165, Max-Change: 0.00021Iteration: 588, Log-Lik: -62873.165, Max-Change: 0.00029Iteration: 589, Log-Lik: -62873.165, Max-Change: 0.00016Iteration: 590, Log-Lik: -62873.165, Max-Change: 0.00021Iteration: 591, Log-Lik: -62873.165, Max-Change: 0.00029Iteration: 592, Log-Lik: -62873.165, Max-Change: 0.00016Iteration: 593, Log-Lik: -62873.165, Max-Change: 0.00021Iteration: 594, Log-Lik: -62873.165, Max-Change: 0.00029Iteration: 595, Log-Lik: -62873.165, Max-Change: 0.00015Iteration: 596, Log-Lik: -62873.165, Max-Change: 0.00021Iteration: 597, Log-Lik: -62873.165, Max-Change: 0.00028Iteration: 598, Log-Lik: -62873.165, Max-Change: 0.00016Iteration: 599, Log-Lik: -62873.165, Max-Change: 0.00021Iteration: 600, Log-Lik: -62873.165, Max-Change: 0.00029Iteration: 601, Log-Lik: -62873.165, Max-Change: 0.00015Iteration: 602, Log-Lik: -62873.165, Max-Change: 0.00021Iteration: 603, Log-Lik: -62873.165, Max-Change: 0.00028Iteration: 604, Log-Lik: -62873.165, Max-Change: 0.00015Iteration: 605, Log-Lik: -62873.165, Max-Change: 0.00021Iteration: 606, Log-Lik: -62873.165, Max-Change: 0.00028Iteration: 607, Log-Lik: -62873.165, Max-Change: 0.00015Iteration: 608, Log-Lik: -62873.165, Max-Change: 0.00021Iteration: 609, Log-Lik: -62873.165, Max-Change: 0.00028Iteration: 610, Log-Lik: -62873.165, Max-Change: 0.00015Iteration: 611, Log-Lik: -62873.165, Max-Change: 0.00020Iteration: 612, Log-Lik: -62873.165, Max-Change: 0.00028Iteration: 613, Log-Lik: -62873.165, Max-Change: 0.00015Iteration: 614, Log-Lik: -62873.165, Max-Change: 0.00021Iteration: 615, Log-Lik: -62873.165, Max-Change: 0.00028Iteration: 616, Log-Lik: -62873.165, Max-Change: 0.00015Iteration: 617, Log-Lik: -62873.165, Max-Change: 0.00020Iteration: 618, Log-Lik: -62873.165, Max-Change: 0.00028Iteration: 619, Log-Lik: -62873.165, Max-Change: 0.00015Iteration: 620, Log-Lik: -62873.165, Max-Change: 0.00020Iteration: 621, Log-Lik: -62873.165, Max-Change: 0.00027Iteration: 622, Log-Lik: -62873.165, Max-Change: 0.00015Iteration: 623, Log-Lik: -62873.164, Max-Change: 0.00020Iteration: 624, Log-Lik: -62873.164, Max-Change: 0.00027Iteration: 625, Log-Lik: -62873.164, Max-Change: 0.00015Iteration: 626, Log-Lik: -62873.164, Max-Change: 0.00020Iteration: 627, Log-Lik: -62873.164, Max-Change: 0.00027Iteration: 628, Log-Lik: -62873.164, Max-Change: 0.00015Iteration: 629, Log-Lik: -62873.164, Max-Change: 0.00020Iteration: 630, Log-Lik: -62873.164, Max-Change: 0.00027Iteration: 631, Log-Lik: -62873.164, Max-Change: 0.00014Iteration: 632, Log-Lik: -62873.164, Max-Change: 0.00020Iteration: 633, Log-Lik: -62873.164, Max-Change: 0.00027Iteration: 634, Log-Lik: -62873.164, Max-Change: 0.00015Iteration: 635, Log-Lik: -62873.164, Max-Change: 0.00020Iteration: 636, Log-Lik: -62873.164, Max-Change: 0.00027Iteration: 637, Log-Lik: -62873.164, Max-Change: 0.00014Iteration: 638, Log-Lik: -62873.164, Max-Change: 0.00020Iteration: 639, Log-Lik: -62873.164, Max-Change: 0.00026Iteration: 640, Log-Lik: -62873.164, Max-Change: 0.00014Iteration: 641, Log-Lik: -62873.164, Max-Change: 0.00019Iteration: 642, Log-Lik: -62873.164, Max-Change: 0.00026Iteration: 643, Log-Lik: -62873.164, Max-Change: 0.00014Iteration: 644, Log-Lik: -62873.164, Max-Change: 0.00019Iteration: 645, Log-Lik: -62873.164, Max-Change: 0.00026Iteration: 646, Log-Lik: -62873.164, Max-Change: 0.00014Iteration: 647, Log-Lik: -62873.164, Max-Change: 0.00019Iteration: 648, Log-Lik: -62873.164, Max-Change: 0.00026Iteration: 649, Log-Lik: -62873.164, Max-Change: 0.00014Iteration: 650, Log-Lik: -62873.164, Max-Change: 0.00019Iteration: 651, Log-Lik: -62873.164, Max-Change: 0.00026Iteration: 652, Log-Lik: -62873.164, Max-Change: 0.00014Iteration: 653, Log-Lik: -62873.164, Max-Change: 0.00019Iteration: 654, Log-Lik: -62873.164, Max-Change: 0.00026Iteration: 655, Log-Lik: -62873.164, Max-Change: 0.00014Iteration: 656, Log-Lik: -62873.164, Max-Change: 0.00019Iteration: 657, Log-Lik: -62873.164, Max-Change: 0.00026Iteration: 658, Log-Lik: -62873.164, Max-Change: 0.00014Iteration: 659, Log-Lik: -62873.164, Max-Change: 0.00019Iteration: 660, Log-Lik: -62873.164, Max-Change: 0.00026Iteration: 661, Log-Lik: -62873.164, Max-Change: 0.00014Iteration: 662, Log-Lik: -62873.164, Max-Change: 0.00019Iteration: 663, Log-Lik: -62873.164, Max-Change: 0.00025Iteration: 664, Log-Lik: -62873.164, Max-Change: 0.00014Iteration: 665, Log-Lik: -62873.164, Max-Change: 0.00018Iteration: 666, Log-Lik: -62873.163, Max-Change: 0.00025Iteration: 667, Log-Lik: -62873.163, Max-Change: 0.00014Iteration: 668, Log-Lik: -62873.163, Max-Change: 0.00019Iteration: 669, Log-Lik: -62873.163, Max-Change: 0.00025Iteration: 670, Log-Lik: -62873.163, Max-Change: 0.00014Iteration: 671, Log-Lik: -62873.163, Max-Change: 0.00018Iteration: 672, Log-Lik: -62873.163, Max-Change: 0.00025Iteration: 673, Log-Lik: -62873.163, Max-Change: 0.00013Iteration: 674, Log-Lik: -62873.163, Max-Change: 0.00018Iteration: 675, Log-Lik: -62873.163, Max-Change: 0.00025Iteration: 676, Log-Lik: -62873.163, Max-Change: 0.00014Iteration: 677, Log-Lik: -62873.163, Max-Change: 0.00018Iteration: 678, Log-Lik: -62873.163, Max-Change: 0.00025Iteration: 679, Log-Lik: -62873.163, Max-Change: 0.00013Iteration: 680, Log-Lik: -62873.163, Max-Change: 0.00018Iteration: 681, Log-Lik: -62873.163, Max-Change: 0.00024Iteration: 682, Log-Lik: -62873.163, Max-Change: 0.00013Iteration: 683, Log-Lik: -62873.163, Max-Change: 0.00018Iteration: 684, Log-Lik: -62873.163, Max-Change: 0.00025Iteration: 685, Log-Lik: -62873.163, Max-Change: 0.00013Iteration: 686, Log-Lik: -62873.163, Max-Change: 0.00018Iteration: 687, Log-Lik: -62873.163, Max-Change: 0.00024Iteration: 688, Log-Lik: -62873.163, Max-Change: 0.00013Iteration: 689, Log-Lik: -62873.163, Max-Change: 0.00018Iteration: 690, Log-Lik: -62873.163, Max-Change: 0.00024Iteration: 691, Log-Lik: -62873.163, Max-Change: 0.00013Iteration: 692, Log-Lik: -62873.163, Max-Change: 0.00018Iteration: 693, Log-Lik: -62873.163, Max-Change: 0.00024Iteration: 694, Log-Lik: -62873.163, Max-Change: 0.00013Iteration: 695, Log-Lik: -62873.163, Max-Change: 0.00018Iteration: 696, Log-Lik: -62873.163, Max-Change: 0.00024Iteration: 697, Log-Lik: -62873.163, Max-Change: 0.00013Iteration: 698, Log-Lik: -62873.163, Max-Change: 0.00018Iteration: 699, Log-Lik: -62873.163, Max-Change: 0.00024Iteration: 700, Log-Lik: -62873.163, Max-Change: 0.00013Iteration: 701, Log-Lik: -62873.163, Max-Change: 0.00017Iteration: 702, Log-Lik: -62873.163, Max-Change: 0.00024Iteration: 703, Log-Lik: -62873.163, Max-Change: 0.00013Iteration: 704, Log-Lik: -62873.163, Max-Change: 0.00018Iteration: 705, Log-Lik: -62873.163, Max-Change: 0.00023Iteration: 706, Log-Lik: -62873.163, Max-Change: 0.00013Iteration: 707, Log-Lik: -62873.163, Max-Change: 0.00017Iteration: 708, Log-Lik: -62873.163, Max-Change: 0.00024Iteration: 709, Log-Lik: -62873.163, Max-Change: 0.00013Iteration: 710, Log-Lik: -62873.163, Max-Change: 0.00017Iteration: 711, Log-Lik: -62873.163, Max-Change: 0.00023Iteration: 712, Log-Lik: -62873.163, Max-Change: 0.00013Iteration: 713, Log-Lik: -62873.163, Max-Change: 0.00017Iteration: 714, Log-Lik: -62873.163, Max-Change: 0.00023Iteration: 715, Log-Lik: -62873.163, Max-Change: 0.00012Iteration: 716, Log-Lik: -62873.163, Max-Change: 0.00017Iteration: 717, Log-Lik: -62873.162, Max-Change: 0.00023Iteration: 718, Log-Lik: -62873.162, Max-Change: 0.00013Iteration: 719, Log-Lik: -62873.162, Max-Change: 0.00017Iteration: 720, Log-Lik: -62873.162, Max-Change: 0.00023Iteration: 721, Log-Lik: -62873.162, Max-Change: 0.00012Iteration: 722, Log-Lik: -62873.162, Max-Change: 0.00017Iteration: 723, Log-Lik: -62873.162, Max-Change: 0.00023Iteration: 724, Log-Lik: -62873.162, Max-Change: 0.00012Iteration: 725, Log-Lik: -62873.162, Max-Change: 0.00017Iteration: 726, Log-Lik: -62873.162, Max-Change: 0.00023Iteration: 727, Log-Lik: -62873.162, Max-Change: 0.00012Iteration: 728, Log-Lik: -62873.162, Max-Change: 0.00017Iteration: 729, Log-Lik: -62873.162, Max-Change: 0.00022Iteration: 730, Log-Lik: -62873.162, Max-Change: 0.00012Iteration: 731, Log-Lik: -62873.162, Max-Change: 0.00016Iteration: 732, Log-Lik: -62873.162, Max-Change: 0.00023Iteration: 733, Log-Lik: -62873.162, Max-Change: 0.00012Iteration: 734, Log-Lik: -62873.162, Max-Change: 0.00017Iteration: 735, Log-Lik: -62873.162, Max-Change: 0.00022Iteration: 736, Log-Lik: -62873.162, Max-Change: 0.00012Iteration: 737, Log-Lik: -62873.162, Max-Change: 0.00016Iteration: 738, Log-Lik: -62873.162, Max-Change: 0.00022Iteration: 739, Log-Lik: -62873.162, Max-Change: 0.00012Iteration: 740, Log-Lik: -62873.162, Max-Change: 0.00016Iteration: 741, Log-Lik: -62873.162, Max-Change: 0.00022Iteration: 742, Log-Lik: -62873.162, Max-Change: 0.00012Iteration: 743, Log-Lik: -62873.162, Max-Change: 0.00016Iteration: 744, Log-Lik: -62873.162, Max-Change: 0.00022Iteration: 745, Log-Lik: -62873.162, Max-Change: 0.00012Iteration: 746, Log-Lik: -62873.162, Max-Change: 0.00016Iteration: 747, Log-Lik: -62873.162, Max-Change: 0.00022Iteration: 748, Log-Lik: -62873.162, Max-Change: 0.00012Iteration: 749, Log-Lik: -62873.162, Max-Change: 0.00016Iteration: 750, Log-Lik: -62873.162, Max-Change: 0.00022Iteration: 751, Log-Lik: -62873.162, Max-Change: 0.00012Iteration: 752, Log-Lik: -62873.162, Max-Change: 0.00016Iteration: 753, Log-Lik: -62873.162, Max-Change: 0.00022Iteration: 754, Log-Lik: -62873.162, Max-Change: 0.00012Iteration: 755, Log-Lik: -62873.162, Max-Change: 0.00016Iteration: 756, Log-Lik: -62873.162, Max-Change: 0.00022Iteration: 757, Log-Lik: -62873.162, Max-Change: 0.00012Iteration: 758, Log-Lik: -62873.162, Max-Change: 0.00016Iteration: 759, Log-Lik: -62873.162, Max-Change: 0.00021Iteration: 760, Log-Lik: -62873.162, Max-Change: 0.00012Iteration: 761, Log-Lik: -62873.162, Max-Change: 0.00016Iteration: 762, Log-Lik: -62873.162, Max-Change: 0.00021Iteration: 763, Log-Lik: -62873.162, Max-Change: 0.00011Iteration: 764, Log-Lik: -62873.162, Max-Change: 0.00016Iteration: 765, Log-Lik: -62873.162, Max-Change: 0.00021Iteration: 766, Log-Lik: -62873.162, Max-Change: 0.00012Iteration: 767, Log-Lik: -62873.162, Max-Change: 0.00015Iteration: 768, Log-Lik: -62873.162, Max-Change: 0.00021Iteration: 769, Log-Lik: -62873.162, Max-Change: 0.00011Iteration: 770, Log-Lik: -62873.162, Max-Change: 0.00016Iteration: 771, Log-Lik: -62873.162, Max-Change: 0.00021Iteration: 772, Log-Lik: -62873.162, Max-Change: 0.00011Iteration: 773, Log-Lik: -62873.162, Max-Change: 0.00015Iteration: 774, Log-Lik: -62873.162, Max-Change: 0.00021Iteration: 775, Log-Lik: -62873.162, Max-Change: 0.00011Iteration: 776, Log-Lik: -62873.162, Max-Change: 0.00015Iteration: 777, Log-Lik: -62873.162, Max-Change: 0.00021Iteration: 778, Log-Lik: -62873.162, Max-Change: 0.00011Iteration: 779, Log-Lik: -62873.161, Max-Change: 0.00015Iteration: 780, Log-Lik: -62873.161, Max-Change: 0.00021Iteration: 781, Log-Lik: -62873.161, Max-Change: 0.00011Iteration: 782, Log-Lik: -62873.161, Max-Change: 0.00015Iteration: 783, Log-Lik: -62873.161, Max-Change: 0.00020Iteration: 784, Log-Lik: -62873.161, Max-Change: 0.00011Iteration: 785, Log-Lik: -62873.161, Max-Change: 0.00015Iteration: 786, Log-Lik: -62873.161, Max-Change: 0.00021Iteration: 787, Log-Lik: -62873.161, Max-Change: 0.00011Iteration: 788, Log-Lik: -62873.161, Max-Change: 0.00015Iteration: 789, Log-Lik: -62873.161, Max-Change: 0.00020Iteration: 790, Log-Lik: -62873.161, Max-Change: 0.00011Iteration: 791, Log-Lik: -62873.161, Max-Change: 0.00015Iteration: 792, Log-Lik: -62873.161, Max-Change: 0.00020Iteration: 793, Log-Lik: -62873.161, Max-Change: 0.00011Iteration: 794, Log-Lik: -62873.161, Max-Change: 0.00015Iteration: 795, Log-Lik: -62873.161, Max-Change: 0.00020Iteration: 796, Log-Lik: -62873.161, Max-Change: 0.00011Iteration: 797, Log-Lik: -62873.161, Max-Change: 0.00015Iteration: 798, Log-Lik: -62873.161, Max-Change: 0.00020Iteration: 799, Log-Lik: -62873.161, Max-Change: 0.00011Iteration: 800, Log-Lik: -62873.161, Max-Change: 0.00015Iteration: 801, Log-Lik: -62873.161, Max-Change: 0.00020Iteration: 802, Log-Lik: -62873.161, Max-Change: 0.00011Iteration: 803, Log-Lik: -62873.161, Max-Change: 0.00014Iteration: 804, Log-Lik: -62873.161, Max-Change: 0.00020Iteration: 805, Log-Lik: -62873.161, Max-Change: 0.00011Iteration: 806, Log-Lik: -62873.161, Max-Change: 0.00015Iteration: 807, Log-Lik: -62873.161, Max-Change: 0.00020Iteration: 808, Log-Lik: -62873.161, Max-Change: 0.00011Iteration: 809, Log-Lik: -62873.161, Max-Change: 0.00014Iteration: 810, Log-Lik: -62873.161, Max-Change: 0.00020Iteration: 811, Log-Lik: -62873.161, Max-Change: 0.00010Iteration: 812, Log-Lik: -62873.161, Max-Change: 0.00014Iteration: 813, Log-Lik: -62873.161, Max-Change: 0.00019Iteration: 814, Log-Lik: -62873.161, Max-Change: 0.00011Iteration: 815, Log-Lik: -62873.161, Max-Change: 0.00014Iteration: 816, Log-Lik: -62873.161, Max-Change: 0.00019Iteration: 817, Log-Lik: -62873.161, Max-Change: 0.00010Iteration: 818, Log-Lik: -62873.161, Max-Change: 0.00014Iteration: 819, Log-Lik: -62873.161, Max-Change: 0.00019Iteration: 820, Log-Lik: -62873.161, Max-Change: 0.00011Iteration: 821, Log-Lik: -62873.161, Max-Change: 0.00014Iteration: 822, Log-Lik: -62873.161, Max-Change: 0.00019Iteration: 823, Log-Lik: -62873.161, Max-Change: 0.00010Iteration: 824, Log-Lik: -62873.161, Max-Change: 0.00014Iteration: 825, Log-Lik: -62873.161, Max-Change: 0.00019Iteration: 826, Log-Lik: -62873.161, Max-Change: 0.00010Iteration: 827, Log-Lik: -62873.161, Max-Change: 0.00014Iteration: 828, Log-Lik: -62873.161, Max-Change: 0.00019Iteration: 829, Log-Lik: -62873.161, Max-Change: 0.00010Iteration: 830, Log-Lik: -62873.161, Max-Change: 0.00014Iteration: 831, Log-Lik: -62873.161, Max-Change: 0.00019Iteration: 832, Log-Lik: -62873.161, Max-Change: 0.00010Iteration: 833, Log-Lik: -62873.161, Max-Change: 0.00014Iteration: 834, Log-Lik: -62873.161, Max-Change: 0.00019Iteration: 835, Log-Lik: -62873.161, Max-Change: 0.00010Iteration: 836, Log-Lik: -62873.161, Max-Change: 0.00014Iteration: 837, Log-Lik: -62873.161, Max-Change: 0.00019Iteration: 838, Log-Lik: -62873.161, Max-Change: 0.00010Iteration: 839, Log-Lik: -62873.161, Max-Change: 0.00014Iteration: 840, Log-Lik: -62873.161, Max-Change: 0.00019Iteration: 841, Log-Lik: -62873.161, Max-Change: 0.00010
irt_pol_all_rev
## 
## Call:
## mirt(data = pol_vars_num_rev, model = 1, itemtype = pol_vars_options$itemtype, 
##     technical = list(NCYCLES = 5000))
## 
## Full-information item factor analysis with 1 factor(s).
## Converged within 1e-04 tolerance after 841 EM iterations.
## mirt version: 1.44.0 
## M-step optimizer: BFGS 
## EM acceleration: Ramsay 
## Number of rectangular quadrature: 61
## Latent density type: Gaussian 
## 
## Log-likelihood = -62873
## Estimated parameters: 287 
## AIC = 126320
## BIC = 127722; SABIC = 126811
## G2 (1e+10) = 112278, p = 1
## RMSEA = 0, CFI = NaN, TLI = NaN
irt_pol_all_rev %>% summary()
##                                                                                                                                                                                      F1
## There_are_objective_measures_of_beauty_How_much_do_you_agree_with_the_following_statements                                                                                        0.292
## The_label_overweight_is_offensive_How_much_do_you_agree_with_the_following_statements                                                                                             0.107
## Beauty_standards_are_oppressive_How_much_do_you_agree_with_the_following_statements                                                                                               0.507
## Body_positivity_is_harmful_How_much_do_you_agree_with_the_following_statements                                                                                                    0.282
## I_support_the_LGBT_community_How_much_do_you_agree_with_the_following_statements                                                                                                  0.888
## Homosexual_behavior_is_fine_when_it_is_private_and_chaste_How_much_do_you_agree_with_the_following_statements                                                                     0.106
## There_is_nothing_wrong_with_public_depictions_of_homosexual_relationships_How_much_do_you_agree_with_the_following_statements                                                     0.868
## I_support_gay_marriage_How_much_do_you_agree_with_the_following_statements                                                                                                        0.870
## There_is_nothing_wrong_with_attending_a_gay_orgy_How_much_do_you_agree_with_the_following_statements                                                                              0.763
## Children_should_be_taught_about_gay_sex_in_sex_education_classes_How_much_do_you_agree_with_the_following_statements                                                              0.776
## There_are_only_two_genders_How_much_do_you_agree_with_the_following_statements                                                                                                    0.846
## Everyone_be_addressed_by_their_desired_pronouns_How_much_do_you_agree_with_the_following_statements                                                                               0.850
## I_support_feminism_How_much_do_you_agree_with_the_following_statements                                                                                                            0.835
## The_country_would_be_better_if_women_couldn_t_vote_How_much_do_you_agree_with_the_following_statements                                                                            0.516
## Women_should_try_to_be_married_by_the_age_of_25_How_much_do_you_agree_with_the_following_statements                                                                               0.501
## The_government_should_help_ensure_sexual_equality_by_making_sure_women_are_not_discriminated_against_in_private_hiring_How_much_do_you_agree_with_the_following_statements        0.693
## Women_should_hold_the_majority_of_the_positions_of_power_in_society_How_much_do_you_agree_with_the_following_statements                                                           0.542
## Marriage_is_oppressive_for_women_and_monogamy_should_be_moved_away_from_How_much_do_you_agree_with_the_following_statements                                                       0.420
## Men_should_be_masculine_and_women_should_be_feminine_How_much_do_you_agree_with_the_following_statements                                                                          0.760
## Politics_suffers_from_male_overrepresentation_How_much_do_you_agree_with_the_following_statements                                                                                 0.806
## Abortion_should_be_available_to_women_for_use_for_any_reason_How_much_do_you_agree_with_the_following_statements                                                                  0.816
## I_support_sending_more_aid_to_Ukraine_How_much_do_you_agree_with_the_following_statements                                                                                         0.664
## The_Western_response_to_the_Russian_invasion_of_Ukraine_went_too_far_How_much_do_you_agree_with_the_following_statements                                                          0.511
## Progressive_taxation_where_the_rich_are_taxed_at_a_higher_rate_is_the_best_way_to_structure_a_tax_system_How_much_do_you_agree_with_the_following_statements                      0.694
## Reducing_taxes_for_businesses_can_stimulate_economic_growth_How_much_do_you_agree_with_the_following_statements                                                                   0.553
## I_support_Israel_against_Hamas_How_much_do_you_agree_with_the_following_statements                                                                                                0.504
## Israel_is_commiting_genocide_in_Gaza_How_much_do_you_agree_with_the_following_statements                                                                                          0.647
## Black_Lives_Matter_is_a_virtuous_organization_How_much_do_you_agree_with_the_following_statements                                                                                 0.708
## Europe_would_be_best_if_it_remained_all_white_How_much_do_you_agree_with_the_following_statements                                                                                 0.604
## Immigration_policy_should_be_strict_and_heavily_meritorious_How_much_do_you_agree_with_the_following_statements                                                                   0.730
## The_government_should_ensure_racial_equality_by_prohibiting_racial_discrimination_in_private_business_dealings_such_as_hiring_How_much_do_you_agree_with_the_following_statements 0.641
## Black_people_deserve_reparations_for_the_legacy_of_slavery_How_much_do_you_agree_with_the_following_statements                                                                    0.621
## I_support_open_borders_How_much_do_you_agree_with_the_following_statements                                                                                                        0.615
## Politics_suffers_from_white_overrepresentation_How_much_do_you_agree_with_the_following_statements                                                                                0.822
## Affirmative_action_is_discrimination_How_much_do_you_agree_with_the_following_statements                                                                                          0.627
## Compared_to_other_civilizations_Western_civilization_is_uniquely_evil_How_much_do_you_agree_with_the_following_statements                                                         0.248
## Racial_diversity_is_more_important_than_viewpoint_diversity_How_much_do_you_agree_with_the_following_statements                                                                   0.434
## The_world_is_suffering_from_overpopulation_How_much_do_you_agree_with_the_following_statements                                                                                    0.379
## I_feel_overwhelmed_or_anxious_by_climate_change_How_much_do_you_agree_with_the_following_statements                                                                               0.650
## Public_policy_changes_do_not_need_to_be_made_to_deal_with_climate_change_How_much_do_you_agree_with_the_following_statements                                                      0.670
## Are_you_politically_left_wing_or_right_wing                                                                                                                                       0.767
##                                                                                                                                                                                       h2
## There_are_objective_measures_of_beauty_How_much_do_you_agree_with_the_following_statements                                                                                        0.0853
## The_label_overweight_is_offensive_How_much_do_you_agree_with_the_following_statements                                                                                             0.0115
## Beauty_standards_are_oppressive_How_much_do_you_agree_with_the_following_statements                                                                                               0.2573
## Body_positivity_is_harmful_How_much_do_you_agree_with_the_following_statements                                                                                                    0.0798
## I_support_the_LGBT_community_How_much_do_you_agree_with_the_following_statements                                                                                                  0.7893
## Homosexual_behavior_is_fine_when_it_is_private_and_chaste_How_much_do_you_agree_with_the_following_statements                                                                     0.0113
## There_is_nothing_wrong_with_public_depictions_of_homosexual_relationships_How_much_do_you_agree_with_the_following_statements                                                     0.7531
## I_support_gay_marriage_How_much_do_you_agree_with_the_following_statements                                                                                                        0.7569
## There_is_nothing_wrong_with_attending_a_gay_orgy_How_much_do_you_agree_with_the_following_statements                                                                              0.5824
## Children_should_be_taught_about_gay_sex_in_sex_education_classes_How_much_do_you_agree_with_the_following_statements                                                              0.6016
## There_are_only_two_genders_How_much_do_you_agree_with_the_following_statements                                                                                                    0.7153
## Everyone_be_addressed_by_their_desired_pronouns_How_much_do_you_agree_with_the_following_statements                                                                               0.7223
## I_support_feminism_How_much_do_you_agree_with_the_following_statements                                                                                                            0.6978
## The_country_would_be_better_if_women_couldn_t_vote_How_much_do_you_agree_with_the_following_statements                                                                            0.2663
## Women_should_try_to_be_married_by_the_age_of_25_How_much_do_you_agree_with_the_following_statements                                                                               0.2507
## The_government_should_help_ensure_sexual_equality_by_making_sure_women_are_not_discriminated_against_in_private_hiring_How_much_do_you_agree_with_the_following_statements        0.4808
## Women_should_hold_the_majority_of_the_positions_of_power_in_society_How_much_do_you_agree_with_the_following_statements                                                           0.2939
## Marriage_is_oppressive_for_women_and_monogamy_should_be_moved_away_from_How_much_do_you_agree_with_the_following_statements                                                       0.1763
## Men_should_be_masculine_and_women_should_be_feminine_How_much_do_you_agree_with_the_following_statements                                                                          0.5780
## Politics_suffers_from_male_overrepresentation_How_much_do_you_agree_with_the_following_statements                                                                                 0.6493
## Abortion_should_be_available_to_women_for_use_for_any_reason_How_much_do_you_agree_with_the_following_statements                                                                  0.6663
## I_support_sending_more_aid_to_Ukraine_How_much_do_you_agree_with_the_following_statements                                                                                         0.4403
## The_Western_response_to_the_Russian_invasion_of_Ukraine_went_too_far_How_much_do_you_agree_with_the_following_statements                                                          0.2607
## Progressive_taxation_where_the_rich_are_taxed_at_a_higher_rate_is_the_best_way_to_structure_a_tax_system_How_much_do_you_agree_with_the_following_statements                      0.4817
## Reducing_taxes_for_businesses_can_stimulate_economic_growth_How_much_do_you_agree_with_the_following_statements                                                                   0.3053
## I_support_Israel_against_Hamas_How_much_do_you_agree_with_the_following_statements                                                                                                0.2538
## Israel_is_commiting_genocide_in_Gaza_How_much_do_you_agree_with_the_following_statements                                                                                          0.4188
## Black_Lives_Matter_is_a_virtuous_organization_How_much_do_you_agree_with_the_following_statements                                                                                 0.5014
## Europe_would_be_best_if_it_remained_all_white_How_much_do_you_agree_with_the_following_statements                                                                                 0.3647
## Immigration_policy_should_be_strict_and_heavily_meritorious_How_much_do_you_agree_with_the_following_statements                                                                   0.5325
## The_government_should_ensure_racial_equality_by_prohibiting_racial_discrimination_in_private_business_dealings_such_as_hiring_How_much_do_you_agree_with_the_following_statements 0.4105
## Black_people_deserve_reparations_for_the_legacy_of_slavery_How_much_do_you_agree_with_the_following_statements                                                                    0.3862
## I_support_open_borders_How_much_do_you_agree_with_the_following_statements                                                                                                        0.3784
## Politics_suffers_from_white_overrepresentation_How_much_do_you_agree_with_the_following_statements                                                                                0.6757
## Affirmative_action_is_discrimination_How_much_do_you_agree_with_the_following_statements                                                                                          0.3928
## Compared_to_other_civilizations_Western_civilization_is_uniquely_evil_How_much_do_you_agree_with_the_following_statements                                                         0.0616
## Racial_diversity_is_more_important_than_viewpoint_diversity_How_much_do_you_agree_with_the_following_statements                                                                   0.1885
## The_world_is_suffering_from_overpopulation_How_much_do_you_agree_with_the_following_statements                                                                                    0.1440
## I_feel_overwhelmed_or_anxious_by_climate_change_How_much_do_you_agree_with_the_following_statements                                                                               0.4231
## Public_policy_changes_do_not_need_to_be_made_to_deal_with_climate_change_How_much_do_you_agree_with_the_following_statements                                                      0.4485
## Are_you_politically_left_wing_or_right_wing                                                                                                                                       0.5878
## 
## SS loadings:  17.1 
## Proportion Var:  0.417 
## 
## Factor correlations: 
## 
##    F1
## F1  1
#item stats
irt_pol_all_rev_item_stats = get_mirt_stats(irt_pol_all_rev)
irt_pol_all_rev_item_stats$loading %>% describe2()
#scores
irt_pol_all_rev_scores = fscores(irt_pol_all_rev, full.scores = T, full.scores.SE = T)
d$leftism_rev = irt_pol_all_rev_scores[, 1] %>% standardize()

#reliability
empirical_rxx(irt_pol_all_rev_scores)
##    F1 
## 0.968
marginal_rxx(irt_pol_all_rev)
## [1] 0.969
get_reliabilities(irt_pol_all_rev) %>% 
  ggplot(aes(z, rel)) +
  geom_line()

#plot
d %>% 
  GG_denhist("leftism_rev")
## `stat_bin()` using `bins = 30`. Pick better value with `binwidth`.

#compare
GG_scatter(d, "leftism", "leftism_rev") + 
  geom_smooth()
## `geom_smooth()` using formula = 'y ~ x'
## `geom_smooth()` using method = 'loess' and formula = 'y ~ x'

Body modifications

#fit a general score of body mods
irt_body_mods = mirt(
  d %>% select(tattoos_count2, piercings_count2, unnatural_hair) %>% map_df(as.numeric),
  itemtype = c("graded", "graded", "2PL"),
  model = 1
)
## Iteration: 1, Log-Lik: -2456.337, Max-Change: 0.53575Iteration: 2, Log-Lik: -2432.937, Max-Change: 0.20392Iteration: 3, Log-Lik: -2421.852, Max-Change: 0.15198Iteration: 4, Log-Lik: -2416.910, Max-Change: 0.11245Iteration: 5, Log-Lik: -2414.781, Max-Change: 0.08232Iteration: 6, Log-Lik: -2413.837, Max-Change: 0.06228Iteration: 7, Log-Lik: -2413.100, Max-Change: 0.03401Iteration: 8, Log-Lik: -2412.999, Max-Change: 0.02806Iteration: 9, Log-Lik: -2412.934, Max-Change: 0.02514Iteration: 10, Log-Lik: -2412.789, Max-Change: 0.01175Iteration: 11, Log-Lik: -2412.781, Max-Change: 0.00563Iteration: 12, Log-Lik: -2412.777, Max-Change: 0.00678Iteration: 13, Log-Lik: -2412.768, Max-Change: 0.00257Iteration: 14, Log-Lik: -2412.767, Max-Change: 0.00166Iteration: 15, Log-Lik: -2412.766, Max-Change: 0.00223Iteration: 16, Log-Lik: -2412.766, Max-Change: 0.00247Iteration: 17, Log-Lik: -2412.765, Max-Change: 0.00098Iteration: 18, Log-Lik: -2412.765, Max-Change: 0.00223Iteration: 19, Log-Lik: -2412.765, Max-Change: 0.00084Iteration: 20, Log-Lik: -2412.765, Max-Change: 0.00042Iteration: 21, Log-Lik: -2412.765, Max-Change: 0.00030Iteration: 22, Log-Lik: -2412.765, Max-Change: 0.00026Iteration: 23, Log-Lik: -2412.765, Max-Change: 0.00049Iteration: 24, Log-Lik: -2412.765, Max-Change: 0.00011Iteration: 25, Log-Lik: -2412.765, Max-Change: 0.00048Iteration: 26, Log-Lik: -2412.765, Max-Change: 0.00017Iteration: 27, Log-Lik: -2412.765, Max-Change: 0.00046Iteration: 28, Log-Lik: -2412.765, Max-Change: 0.00214Iteration: 29, Log-Lik: -2412.765, Max-Change: 0.00059Iteration: 30, Log-Lik: -2412.765, Max-Change: 0.00045Iteration: 31, Log-Lik: -2412.765, Max-Change: 0.00018Iteration: 32, Log-Lik: -2412.765, Max-Change: 0.00027Iteration: 33, Log-Lik: -2412.765, Max-Change: 0.00025Iteration: 34, Log-Lik: -2412.765, Max-Change: 0.00029Iteration: 35, Log-Lik: -2412.765, Max-Change: 0.00030Iteration: 36, Log-Lik: -2412.765, Max-Change: 0.00011Iteration: 37, Log-Lik: -2412.765, Max-Change: 0.00010
irt_body_mods
## 
## Call:
## mirt(data = d %>% select(tattoos_count2, piercings_count2, unnatural_hair) %>% 
##     map_df(as.numeric), model = 1, itemtype = c("graded", "graded", 
##     "2PL"))
## 
## Full-information item factor analysis with 1 factor(s).
## Converged within 1e-04 tolerance after 37 EM iterations.
## mirt version: 1.44.0 
## M-step optimizer: BFGS 
## EM acceleration: Ramsay 
## Number of rectangular quadrature: 61
## Latent density type: Gaussian 
## 
## Log-likelihood = -2413
## Estimated parameters: 12 
## AIC = 4850
## BIC = 4908; SABIC = 4870
## G2 (35) = 47.6, p = 0.0757
## RMSEA = 0.019, CFI = NaN, TLI = NaN
irt_body_mods %>% summary()
##                     F1    h2
## tattoos_count2   0.667 0.445
## piercings_count2 0.742 0.551
## unnatural_hair   0.643 0.414
## 
## SS loadings:  1.41 
## Proportion Var:  0.47 
## 
## Factor correlations: 
## 
##    F1
## F1  1
#scores
irt_body_mods_scores = fscores(irt_body_mods, full.scores = T, full.scores.SE = T)
d$body_mods = irt_body_mods_scores[, 1] %>% standardize()

#reliability
empirical_rxx(irt_body_mods_scores)
##    F1 
## 0.568
marginal_rxx(irt_body_mods)
## [1] 0.558
get_reliabilities(irt_body_mods) %>% 
  ggplot(aes(z, rel)) +
  geom_line()

#plot
d %>% 
  GG_denhist("body_mods")
## `stat_bin()` using `bins = 30`. Pick better value with `binwidth`.

#counts of body mods by sex
d %>% 
  select(Tattoo_Hand:Piercing_Other, unnatural_hair, sex) %>% 
  mutate(
    unnatural_hair = as.logical(unnatural_hair)
  ) %>% 
  pivot_longer(
    cols = c(Tattoo_Hand:Piercing_Other, unnatural_hair)
  ) %>% 
  GG_group_means("value", "name", "sex") +
  coord_flip() +
  labs(
    y = "% with body modification",
    x = "Body modification type",
    fill = "Sex"
  ) +
  scale_y_continuous(labels = scales::percent_format(accuracy = 1))
## Proportion variable detected, using `prop.test()`

Main analyses

Leftism ~ mental health

#correlation matrix
p_cor_mat = d %>% 
  select(p_symptoms, p_diag, p_mmpi, p_last2weeks, p_satisfaction, tattoos_count2, piercings_count2, unnatural_hair, age, female, leftism) %>% 
  as.data.frame() %>% 
  rename(tattoos = tattoos_count2, piercings = piercings_count2, "unnatural hair" = unnatural_hair) %>% 
  plot_cor_mat()

p_cor_mat

GG_save("figs/cor_heatmap.png")

#mental health and leftism
GG_scatter(d, "p_all", "leftism") + 
  geom_smooth()
## `geom_smooth()` using formula = 'y ~ x'
## `geom_smooth()` using method = 'loess' and formula = 'y ~ x'

GG_scatter(d, "p_symptoms", "leftism") + 
  geom_smooth()
## `geom_smooth()` using formula = 'y ~ x'
## `geom_smooth()` using method = 'loess' and formula = 'y ~ x'

GG_scatter(d, "p_diag", "leftism") + 
  geom_smooth()
## `geom_smooth()` using formula = 'y ~ x'
## `geom_smooth()` using method = 'loess' and formula = 'y ~ x'

#by party
d %>% 
  GG_group_means("p_all", "What_is_your_party_registration")

#by self-placement
d %>% 
  GG_group_means("p_all", "Are_you_politically_left_wing_or_right_wing")

#leftism as function of diagnoses count
d %>% 
  GG_group_means("leftism", "P_diag_count2")

#leftism as function of diagnoses any
d %>% 
  GG_group_means("leftism", "P_diag_any")

SMD_matrix(d$leftism, d$P_diag_any)
##        FALSE   TRUE
## FALSE     NA -0.422
## TRUE  -0.422     NA
#by diagnosis
bind_cols(
  leftism = d$leftism,
  mh_vars_num %>% select(-all_of(mh_vars_symptoms)) %>% map_df(~(. - 1)) %>% map_df(as.logical)
) %>% 
  plot_cor_mat()
## Warning in FUN(X[[i]], ...): polychoric correlation between variables Paranoia_Paranoid_personality_disorder and Schizophrenia produced a warning:
##    inadmissible correlation set to 0.9999
## Warning in FUN(X[[i]], ...): polychoric correlation between variables Paranoia_Paranoid_personality_disorder and Schizoid_personality_disorder produced a warning:
##    inadmissible correlation set to 0.9999
## Warning in FUN(X[[i]], ...): polychoric correlation between variables Schizophrenia and Schizoid_personality_disorder produced a warning:
##    inadmissible correlation set to 0.9999
## Warning in hetcor.data.frame(data %>% as.data.frame(), use =
## "pairwise.complete.obs"): the correlation matrix has been adjusted to make it
## positive-definite

#models
leftism_models = list(
  ols(leftism ~ p_diag + p_mmpi + p_last2weeks + p_satisfaction, data = d),
  
  #with controls
  ols(leftism ~ p_diag + age_z + sex + US_born + race2_common, data = d),
  ols(leftism ~ p_mmpi + age_z + sex + US_born + race2_common, data = d),
  ols(leftism ~ p_last2weeks + age_z + sex + US_born + race2_common, data = d),
  ols(leftism ~ p_satisfaction + age_z + sex + US_born + race2_common, data = d),
  ols(leftism ~ p_diag + p_mmpi + p_last2weeks + p_satisfaction + age_z + sex + US_born + race2_common, data = d)
)

leftism_models %>% summarize_models(asterisks_only = F, add_ref_level = F)
leftism_models %>% summarize_models(asterisks_only = F, collapse_factors = "race2_common", add_ref_level = F)

Leftism ~ specific diagnosis

#include each diagnosis
diag_names = mh_vars_num %>% select(Attention_deficit_hyperactivity_disorder_ADHD:Sleeping_disorders) %>% names()

#data subset
d_diag_models = bind_cols(
  d %>% select(leftism, age, male, race2_common),
  mh_vars_num %>% select(Attention_deficit_hyperactivity_disorder_ADHD:Sleeping_disorders)
) %>% miss_filter() %>% mutate(
  Schizoid = (Paranoia_Paranoid_personality_disorder == 2 | Schizophrenia == 2 | Schizoid_personality_disorder == 2) %>% as.numeric()
)

#model strings
diag_form = as.formula(str_glue("leftism ~ age + male + race2_common + {str_c(diag_names, collapse = ' + ')}"))

#merge schizoids
diag_names2 = mh_vars_num %>% select(Attention_deficit_hyperactivity_disorder_ADHD:Sleeping_disorders) %>% select(-Paranoia_Paranoid_personality_disorder, -Schizophrenia, -Schizoid_personality_disorder) %>% names() %>% c("Schizoid")
diag_form2 = as.formula(str_glue("leftism ~ age + male + race2_common + {str_c(diag_names2, collapse = ' + ')}"))

ols(diag_form, data = d_diag_models)
## Linear Regression Model
## 
## ols(formula = diag_form, data = d_diag_models)
## 
##                 Model Likelihood    Discrimination    
##                       Ratio Test           Indexes    
## Obs     976    LR chi2    117.19    R2       0.113    
## sigma0.9536    d.f.           24    R2 adj   0.091    
## d.f.    951    Pr(> chi2) 0.0000    g        0.368    
## 
## Residuals
## 
##      Min       1Q   Median       3Q      Max 
## -2.95952 -0.62429 -0.01733  0.62544  2.72065 
## 
## 
##                                               Coef    S.E.   t     Pr(>|t|)
## Intercept                                      0.9789 0.9771  1.00 0.3167  
## age                                           -0.0079 0.0021 -3.81 0.0001  
## male                                          -0.3003 0.0632 -4.75 <0.0001 
## race2_common=Asian                             0.1676 0.1578  1.06 0.2883  
## race2_common=Black                            -0.1782 0.0944 -1.89 0.0594  
## race2_common=Hispanic                          0.0794 0.1430  0.56 0.5789  
## race2_common=Other                            -0.1200 0.1340 -0.90 0.3707  
## Attention_deficit_hyperactivity_disorder_ADHD  0.3456 0.1081  3.20 0.0014  
## Alcohol_abuse                                  0.0813 0.1562  0.52 0.6030  
## Non_alcohol_drug_abuse                        -0.2256 0.2366 -0.95 0.3405  
## Autism_spectrum_disorder_ASD                   0.2197 0.1876  1.17 0.2418  
## Anti_social_personality_disorder               0.0026 0.2825  0.01 0.9927  
## Bipolarity                                    -0.0497 0.1707 -0.29 0.7710  
## Borderline_Personality_Disorder                0.1343 0.2484  0.54 0.5889  
## Depression                                     0.0641 0.0882  0.73 0.4676  
## General_Anxiety_Disorder_GAD                   0.2749 0.0985  2.79 0.0053  
## Obsessive_compulsive_disorder_OCD              0.0051 0.1726  0.03 0.9764  
## Panic_disorder                                -0.2689 0.1561 -1.72 0.0853  
## Paranoia_Paranoid_personality_disorder        -2.4007 0.8371 -2.87 0.0042  
## Phobias_social                                -0.3056 0.2570 -1.19 0.2348  
## Specific_phobias                               0.4061 0.2658  1.53 0.1269  
## Post_traumatic_stress_disorder_PTSD            0.1647 0.1376  1.20 0.2317  
## Schizophrenia                                  0.4511 0.8376  0.54 0.5903  
## Schizoid_personality_disorder                  0.7112 0.8787  0.81 0.4185  
## Sleeping_disorders                            -0.1600 0.1187 -1.35 0.1781
ols(diag_form2, data = d_diag_models)
## Linear Regression Model
## 
## ols(formula = diag_form2, data = d_diag_models)
## 
##                 Model Likelihood    Discrimination    
##                       Ratio Test           Indexes    
## Obs     976    LR chi2    114.31    R2       0.111    
## sigma0.9540    d.f.           22    R2 adj   0.090    
## d.f.    953    Pr(> chi2) 0.0000    g        0.368    
## 
## Residuals
## 
##      Min       1Q   Median       3Q      Max 
## -2.95415 -0.62336 -0.01166  0.62363  2.69673 
## 
## 
##                                               Coef    S.E.   t     Pr(>|t|)
## Intercept                                     -0.3758 0.4958 -0.76 0.4487  
## age                                           -0.0078 0.0021 -3.79 0.0002  
## male                                          -0.3098 0.0631 -4.91 <0.0001 
## race2_common=Asian                             0.1709 0.1579  1.08 0.2791  
## race2_common=Black                            -0.1677 0.0942 -1.78 0.0753  
## race2_common=Hispanic                          0.0821 0.1431  0.57 0.5661  
## race2_common=Other                            -0.1184 0.1340 -0.88 0.3773  
## Attention_deficit_hyperactivity_disorder_ADHD  0.3264 0.1077  3.03 0.0025  
## Alcohol_abuse                                  0.0746 0.1563  0.48 0.6332  
## Non_alcohol_drug_abuse                        -0.2358 0.2367 -1.00 0.3194  
## Autism_spectrum_disorder_ASD                   0.2019 0.1876  1.08 0.2820  
## Anti_social_personality_disorder               0.1194 0.2791  0.43 0.6688  
## Bipolarity                                    -0.0531 0.1708 -0.31 0.7558  
## Borderline_Personality_Disorder                0.2289 0.2456  0.93 0.3515  
## Depression                                     0.0600 0.0882  0.68 0.4966  
## General_Anxiety_Disorder_GAD                   0.2949 0.0983  3.00 0.0028  
## Obsessive_compulsive_disorder_OCD             -0.0082 0.1727 -0.05 0.9621  
## Panic_disorder                                -0.2442 0.1549 -1.58 0.1153  
## Phobias_social                                -0.3370 0.2569 -1.31 0.1900  
## Specific_phobias                               0.3897 0.2657  1.47 0.1429  
## Post_traumatic_stress_disorder_PTSD            0.1377 0.1375  1.00 0.3166  
## Sleeping_disorders                            -0.1494 0.1186 -1.26 0.2082  
## Schizoid                                      -1.1826 0.4915 -2.41 0.0163
#compare predictors
diag_compare_fit_coefs = compare_predictors(
  data = d_diag_models,
  outcome = "leftism",
  predictors = diag_names2,
  controls = c("age", "male", "race2_common")
)

#adjust p value for multiple testing
diag_compare_fit_coefs$p.value.orig = diag_compare_fit_coefs$p.value
diag_compare_fit_coefs$p.value = p.adjust(diag_compare_fit_coefs$p.value, method = "fdr")

#plot
diag_compare_fit_coefs %>% 
  GG_plot_models(highlight_sig = .05)

GG_save("figs/leftism by diagnosis.png")

Diagnoses ~ leftism + symptoms + covars

pdiag_models = list(
  ols(p_diag ~ leftism + age + male + race2_common, data = d),
  ols(p_diag ~ p_mmpi + p_last2weeks + p_satisfaction + leftism + age + male + race2_common, data = d)
)

pdiag_models %>% summarize_models(collapse_factors = T, add_ref_level = F)
#understand model
gam(p_diag ~ leftism + age + sex + race2_common + s(leftism, by = sex), data = d) %>% ggpredict(terms = c("leftism", "sex", "age")) %>% plot() +
  labs(
    title = "Psychopathology predicted by leftism, age, and sex",
    y = "Psychopathology score (18 diagnoses)",
    x = "Leftism score (50+ items)"
  ) + 
  theme_bw()

GG_save("figs/diag ~ leftism, age, sex, gam.png")

psych ~ body mods

#correlations for tattoos
bind_cols(
  d_tats,
  d %>% select(p_diag, p_mmpi, p_last2weeks, p_satisfaction, age, sex, leftism)
) %>% 
  plot_cor_mat()
## Warning in hetcor.data.frame(data %>% as.data.frame(), use =
## "pairwise.complete.obs"): the correlation matrix has been adjusted to make it
## positive-definite

#correlations for piercings
bind_cols(
  d_piercings,
  d %>% select(p_diag, p_mmpi, p_last2weeks, p_satisfaction, age, sex, leftism)
) %>% 
  plot_cor_mat()
## Warning in hetcor.data.frame(data %>% as.data.frame(), use =
## "pairwise.complete.obs"): the correlation matrix has been adjusted to make it
## positive-definite

#mean leftism by tattoo clusters
d %>% 
  GG_group_means("leftism", "tattoos2")

#mean leftism as binary for each tattoo type
d %>% 
  select(Tattoo_Hand:Tattoo_Other, leftism) %>%
  pivot_longer(-leftism) %>% 
  GG_group_means("leftism", "name", "value") +
  labs(
    x = "Tattoo type",
    y = "Mean leftism",
    title = "Mean leftism by tattoo type"
  ) +
  scale_fill_discrete(name = "Has tattoo?") +
  coord_flip()
## Scale for fill is already present.
## Adding another scale for fill, which will replace the existing scale.

#mean leftism by piercing clusters
d %>% 
  GG_group_means("leftism", "piercings2", add_sample_sizes_to_labels = T)

#mean leftism as binary for each piercing type
d %>% 
  select(Piercing_Ears:Piercing_Other, leftism) %>%
  pivot_longer(-leftism) %>% 
  GG_group_means("leftism", "name", "value") +
  labs(
    x = "Piercing type",
    y = "Mean leftism",
    title = "Mean leftism by piercing type"
  ) +
  scale_fill_discrete(name = "Has piercing?") +
  coord_flip()
## Scale for fill is already present.
## Adding another scale for fill, which will replace the existing scale.

#regression models
body_mod_models = list(
  #leftism ~ 
  leftism1 = ols(leftism ~ tattoos_count + piercings_count + unnatural_hair, data = d),
  leftism2 = ols(leftism ~ tattoos_count + piercings_count + unnatural_hair + age + sex + race2_common, data = d),
  leftism3 = ols(leftism ~ tattoos_count + piercings_count + unnatural_hair + age + sex + race2_common + p_diag, data = d),
  
  #p ~ 
  diag1 = ols(p_diag ~ tattoos_count + piercings_count + unnatural_hair, data = d),
  diag2 = ols(p_diag ~ tattoos_count + piercings_count + unnatural_hair + age + sex + race2_common, data = d),
  diag3 = ols(p_diag ~ tattoos_count + piercings_count + unnatural_hair + age + sex + race2_common + leftism, data = d)
)

body_mod_models %>% summarize_models(asterisks_only = F, collapse_factors = "race2_common", add_ref_level = F) %>% flextable::flextable()

Predictor/Model

leftism1

leftism2

leftism3

diag1

diag2

diag3

Intercept

-0.15 (0.042, <0.001***)

0.60 (0.125, <0.001***)

0.52 (0.124, <0.001***)

-0.18 (0.041, <0.001***)

0.46 (0.122, <0.001***)

0.37 (0.122, 0.002**)

tattoos_count

0.04 (0.030, 0.241)

0.03 (0.030, 0.391)

-0.01 (0.031, 0.852)

0.23 (0.030, <0.001***)

0.20 (0.029, <0.001***)

0.20 (0.029, <0.001***)

piercings_count

0.09 (0.043, 0.03)

-0.01 (0.050, 0.767)

-0.02 (0.049, 0.747)

0.03 (0.042, 0.436)

0.01 (0.048, 0.88)

0.01 (0.048, 0.843)

unnatural_hair = TRUE

0.29 (0.080, <0.001***)

0.24 (0.079, 0.003**)

0.23 (0.078, 0.003**)

0.05 (0.078, 0.528)

0.03 (0.077, 0.67)

0.00 (0.076, 0.976)

age

-0.01 (0.002, <0.001***)

-0.01 (0.002, <0.001***)

-0.01 (0.002, <0.001***)

-0.01 (0.002, <0.001***)

sex = Male

-0.31 (0.075, <0.001***)

-0.30 (0.074, <0.001***)

-0.07 (0.073, 0.317)

-0.03 (0.073, 0.702)

race2_common

(yes)

(yes)

(yes)

(yes)

p_diag

0.15 (0.033, <0.001***)

leftism

0.15 (0.031, <0.001***)

R2 adj.

0.031

0.068

0.089

0.079

0.117

0.136

N

978

976

976

978

976

976

#combined score as predictor
body_mod_models2 = list(
  leftism1 = ols(leftism ~ body_mods, data = d),
  leftism2 = ols(leftism ~ body_mods + age + sex + race2_common, data = d),
  leftism3 = ols(leftism ~ body_mods + age + sex + race2_common + p_diag, data = d),
  
  diag1 = ols(p_diag ~ body_mods, data = d),
  diag2 = ols(p_diag ~ body_mods + age + sex + race2_common, data = d),
  diag3 = ols(p_diag ~ body_mods + age + sex + race2_common + leftism, data = d)
)

body_mod_models2 %>% summarize_models(asterisks_only = F, collapse_factors = "race2_common", add_ref_level = F) %>% flextable::flextable()

Predictor/Model

leftism1

leftism2

leftism3

diag1

diag2

diag3

Intercept

0.00 (0.032, 1)

0.65 (0.112, <0.001***)

0.57 (0.112, <0.001***)

0.00 (0.031, 1)

0.55 (0.109, <0.001***)

0.45 (0.110, <0.001***)

body_mods

0.17 (0.032, <0.001***)

0.07 (0.037, 0.045)

0.04 (0.037, 0.299)

0.24 (0.031, <0.001***)

0.23 (0.036, <0.001***)

0.22 (0.036, <0.001***)

age

-0.01 (0.002, <0.001***)

-0.01 (0.002, <0.001***)

-0.01 (0.002, <0.001***)

-0.01 (0.002, <0.001***)

sex = Male

-0.27 (0.073, <0.001***)

-0.28 (0.073, <0.001***)

0.08 (0.072, 0.253)

0.12 (0.072, 0.09)

race2_common

(yes)

(yes)

(yes)

(yes)

p_diag

0.15 (0.032, <0.001***)

leftism

0.15 (0.031, <0.001***)

R2 adj.

0.028

0.063

0.083

0.055

0.102

0.121

N

978

976

976

978

976

976

#specific tattoos and piercings
d_specific_body_mods = bind_cols(
  d %>% select(leftism, p_diag, age, sex, race2_common, unnatural_hair),
  d_tats %>% df_add_affix(prefix = "tat_"),
  d_piercings %>% df_add_affix(prefix = "pier_")
)

list(
  leftism = ols(as.formula(str_glue("leftism ~ {paste('tat_' + names(d_tats), collapse = ' + ')} + {paste('pier_' + names(d_piercings), collapse = ' + ')} + unnatural_hair + age + sex + race2_common")), data = d_specific_body_mods),
  diag = ols(as.formula(str_glue("p_diag ~ {paste('tat_' + names(d_tats), collapse = ' + ')} + {paste('pier_' + names(d_piercings), collapse = ' + ')} + unnatural_hair + age + sex + race2_common")), data = d_specific_body_mods)
) %>% 
  summarize_models(asterisks_only = F, collapse_factors = "race2_common", add_ref_level = F) %>% 
  flextable::flextable()

Predictor/Model

leftism

diag

Intercept

0.60 (0.134, <0.001***)

0.38 (0.130, 0.004**)

tat_Hand

-0.26 (0.144, 0.074)

0.03 (0.140, 0.818)

tat_Arm

0.10 (0.093, 0.265)

0.41 (0.090, <0.001***)

tat_Chest_or_Stomach

-0.12 (0.137, 0.384)

0.08 (0.133, 0.56)

tat_Back

0.17 (0.118, 0.144)

0.14 (0.115, 0.22)

tat_Neck

-0.21 (0.200, 0.305)

0.08 (0.195, 0.672)

tat_Leg

0.05 (0.119, 0.691)

0.28 (0.115, 0.015)

tat_Feet

0.18 (0.185, 0.326)

-0.04 (0.180, 0.809)

tat_Face_Head

0.03 (0.519, 0.947)

0.21 (0.504, 0.684)

tat_Other

0.11 (0.180, 0.554)

0.63 (0.175, <0.001***)

pier_Ears

-0.07 (0.087, 0.417)

0.13 (0.085, 0.122)

pier_Eyebrow

-0.44 (0.382, 0.252)

-0.25 (0.371, 0.496)

pier_Nose_septum_not_included

0.11 (0.143, 0.43)

-0.19 (0.139, 0.164)

pier_Septum

1.02 (0.296, <0.001***)

0.26 (0.288, 0.363)

pier_Mouth_area_outside_the_mouth

-0.18 (0.322, 0.584)

1.08 (0.313, <0.001***)

pier_Mouth_area_inside_the_mouth

-0.76 (0.350, 0.029)

-0.44 (0.340, 0.192)

pier_Cheek

-0.55 (0.702, 0.435)

-0.49 (0.682, 0.477)

pier_Nipple

0.02 (0.245, 0.933)

-0.16 (0.238, 0.509)

pier_Navel

-0.22 (0.199, 0.274)

-0.08 (0.193, 0.666)

pier_Genital

1.37 (0.461, 0.003**)

-0.37 (0.448, 0.405)

pier_Other

-0.03 (0.567, 0.96)

-0.03 (0.551, 0.961)

unnatural_hair = TRUE

0.23 (0.080, 0.004**)

-0.02 (0.077, 0.807)

age

-0.01 (0.002, <0.001***)

-0.01 (0.002, <0.001***)

sex = Male

-0.33 (0.087, <0.001***)

-0.03 (0.084, 0.725)

race2_common

(yes)

(yes)

R2 adj.

0.084

0.135

N

976

976

#correlations among all body mods and covars

Item-level analyses

Jensen’s method

#we need to get item level data for P and political scales
item_stats_P_all = get_mirt_stats(irt_mh_all)

#which concern diagnoses?
item_stats_P_all$diagnosis = (!item_stats_P_all$item %in% mh_vars_symptoms) %>% factor()

#nice names from file
item_stats_P_all$nice_name = read_csv("data/mh_items.csv") %>% pull(nice_name)
## Rows: 76 Columns: 12
## ── Column specification ────────────────────────────────────────────────────────
## Delimiter: ","
## chr (3): item, nice_name, type
## dbl (7): item_i, loading, difficulty, discrimination, pass_rate, leftism_r, ...
## lgl (2): reversed, diagnosis
## 
## ℹ Use `spec()` to retrieve the full column specification for this data.
## ℹ Specify the column types or set `show_col_types = FALSE` to quiet this message.
#add criterion cors without reversing
item_stats_P_all_norev = add_item_associations_with_criterion_var(
  .item_data = item_stats_P_all,
  .data = bind_cols(d %>% select(age, sex, race2_common, leftism), mh_vars_num),
  criterion_var = "leftism",
  control_vars = c("age", "sex", "race2_common"),
  reverse_negative_loadings = F,
  winsorize_r2_adj = T
)

#add criterion cors
item_stats_P_all = add_item_associations_with_criterion_var(
  .item_data = item_stats_P_all,
  .data = bind_cols(d %>% select(age, sex, race2_common, leftism), mh_vars_num),
  criterion_var = "leftism",
  control_vars = c("age", "sex", "race2_common"),
  reverse_negative_loadings = T,
  winsorize_r2_adj = T
)


#do metrics agree on which items are most important?
GG_scatter(item_stats_P_all, "leftism_r", "leftism_r_inc", case_names = "nice_name") +
  geom_abline(slope = 1, linetype = 2)
## `geom_smooth()` using formula = 'y ~ x'

#loadings and rel with leftism
patchwork::wrap_plots(
  item_stats_P_all %>% 
  GG_scatter("loading", "leftism_r", color = "diagnosis", case_names = "nice_name"),

  item_stats_P_all %>% 
    GG_scatter("loading", "leftism_r_inc", color = "diagnosis", case_names = "nice_name"),
  guides = "collect"
)
## `geom_smooth()` using formula = 'y ~ x'
## `geom_smooth()` using formula = 'y ~ x'

GG_save("figs/Jensen_method_p_leftism.png")
## `geom_smooth()` using formula = 'y ~ x'
## `geom_smooth()` using formula = 'y ~ x'
#p value for paired correlations
psych::paired.r(
  item_stats_P_all %>% select(loading, leftism_r, leftism_r_inc) %>% cor() %>% .[1, 2],
  item_stats_P_all %>% select(loading, leftism_r, leftism_r_inc) %>% cor() %>% .[1, 3],
  item_stats_P_all %>% select(loading, leftism_r, leftism_r_inc) %>% cor() %>% .[2, 3],
  n = nrow(item_stats_P_all)
)
## Call: psych::paired.r(xy = item_stats_P_all %>% select(loading, leftism_r, 
##     leftism_r_inc) %>% cor() %>% .[1, 2], xz = item_stats_P_all %>% 
##     select(loading, leftism_r, leftism_r_inc) %>% cor() %>% .[1, 
##     3], yz = item_stats_P_all %>% select(loading, leftism_r, 
##     leftism_r_inc) %>% cor() %>% .[2, 3], n = nrow(item_stats_P_all))
## [1] "test of difference between two correlated  correlations"
## t = -2.49  With probability =  0.01
#regressions
item_stats_P_all_mods = list(
  r_1 = lm(leftism_r ~ loading, data = item_stats_P_all),
  r_2 = lm(leftism_r ~ loading + diagnosis, data = item_stats_P_all),
  r_3 = lm(leftism_r ~ loading * diagnosis, data = item_stats_P_all),
  
  r_inc_1 = lm(leftism_r_inc ~ loading, data = item_stats_P_all),
  r_inc_2 = lm(leftism_r_inc ~ loading + diagnosis, data = item_stats_P_all),
  r_inc_3 = lm(leftism_r_inc ~ loading * diagnosis, data = item_stats_P_all)
)

item_stats_P_all_mods %>% summarize_models(asterisks_only = F)

Leftism comparison

#add criterion cors
item_stats_leftism = add_item_associations_with_criterion_var(
  .item_data = irt_pol_all_rev_item_stats,
  .data = bind_cols(d %>% select(age, sex, race2_common, p_diag, p_symptoms), pol_vars_num_rev),
  criterion_var = "p_diag",
  control_vars = c("age", "sex", "race2_common"),
  reverse_negative_loadings = T,
  winsorize_r2_adj = T
)

#for symptoms
item_stats_leftism = add_item_associations_with_criterion_var(
  .item_data = item_stats_leftism,
  .data = bind_cols(d %>% select(age, sex, race2_common, p_diag, p_symptoms), pol_vars_num_rev),
  criterion_var = "p_symptoms",
  control_vars = c("age", "sex", "race2_common"),
  reverse_negative_loadings = T,
  winsorize_r2_adj = T
)

item_stats_leftism %>% print(n = 100)
## # A tibble: 41 × 11
##    item_i item     loading difficulty discrimination pass_rate reversed p_diag_r
##     <int> <chr>      <dbl>      <dbl>          <dbl>     <dbl> <lgl>       <dbl>
##  1      1 There_a…   0.292      2.18           0.520   1.48e-2 FALSE      0.142 
##  2      2 The_lab…   0.107      1.85           0.183   3.24e-2 FALSE      0.0125
##  3      3 Beauty_…   0.507      3.29           1.00    4.92e-4 FALSE      0.183 
##  4      4 Body_po…   0.282      3.56           0.501   1.86e-4 FALSE      0.0335
##  5      5 I_suppo…   0.888      4.54           3.29    2.86e-6 FALSE      0.189 
##  6      6 Homosex…   0.106      1.75           0.182   4.01e-2 FALSE     -0.0241
##  7      7 There_i…   0.868      3.88           2.97    5.24e-5 FALSE      0.179 
##  8      8 I_suppo…   0.870      3.65           3.00    1.30e-4 FALSE      0.217 
##  9      9 There_i…   0.763      1.37           2.01    8.49e-2 FALSE      0.208 
## 10     10 Childre…   0.776      1.49           2.09    6.85e-2 FALSE      0.127 
## 11     11 There_a…   0.846      1.35           2.70    8.88e-2 FALSE      0.169 
## 12     12 Everyon…   0.850      3.27           2.74    5.40e-4 FALSE      0.155 
## 13     13 I_suppo…   0.835      4.85           2.59    6.31e-7 FALSE      0.115 
## 14     14 The_cou…   0.516      5.04           1.03    2.34e-7 FALSE      0.0738
## 15     15 Women_s…   0.501      4.63           0.984   1.81e-6 FALSE      0.109 
## 16     16 The_gov…   0.693      4.14           1.64    1.72e-5 FALSE      0.0922
## 17     17 Women_s…   0.542      2.04           1.10    2.08e-2 FALSE      0.0857
## 18     18 Marriag…   0.420      0.845          0.787   1.99e-1 FALSE      0.115 
## 19     19 Men_sho…   0.760      3.08           1.99    1.04e-3 FALSE      0.180 
## 20     20 Politic…   0.806      4.14           2.32    1.72e-5 FALSE      0.152 
## 21     21 Abortio…   0.816      2.95           2.40    1.57e-3 FALSE      0.140 
## 22     22 I_suppo…   0.664      2.37           1.51    8.80e-3 FALSE      0.0406
## 23     23 The_Wes…   0.511      2.72           1.01    3.25e-3 FALSE      0.0207
## 24     24 Progres…   0.694      4.10           1.64    2.06e-5 FALSE      0.182 
## 25     25 Reducin…   0.553      2.85           1.13    2.17e-3 FALSE      0.0918
## 26     26 I_suppo…   0.504      1.97           0.993   2.41e-2 FALSE      0.134 
## 27     27 Israel_…   0.647      2.81           1.44    2.49e-3 FALSE      0.155 
## 28     28 Black_L…   0.708      2.27           1.71    1.16e-2 FALSE      0.0861
## 29     29 Europe_…   0.604      4.36           1.29    6.58e-6 FALSE      0.0764
## 30     30 Immigra…   0.730      3.03           1.82    1.20e-3 FALSE      0.0907
## 31     31 The_gov…   0.641      3.64           1.42    1.39e-4 FALSE      0.119 
## 32     32 Black_p…   0.621      1.50           1.35    6.63e-2 FALSE      0.0607
## 33     33 I_suppo…   0.615      1.17           1.33    1.21e-1 FALSE      0.142 
## 34     34 Politic…   0.822      3.60           2.46    1.61e-4 FALSE      0.113 
## 35     35 Affirma…   0.627      2.71           1.37    3.32e-3 FALSE      0.0629
## 36     36 Compare…   0.248      1.33           0.436   9.16e-2 FALSE      0.165 
## 37     37 Racial_…   0.434      2.45           0.820   7.11e-3 FALSE      0.0811
## 38     38 The_wor…   0.379      2.48           0.698   6.49e-3 FALSE      0.129 
## 39     39 I_feel_…   0.650      2.63           1.46    4.31e-3 FALSE      0.162 
## 40     40 Public_…   0.670      3.58           1.53    1.71e-4 FALSE      0.0707
## 41     41 Are_you…   0.767      3.75           2.03    8.97e-5 FALSE      0.138 
## # ℹ 3 more variables: p_diag_r_inc <dbl>, p_symptoms_r <dbl>,
## #   p_symptoms_r_inc <dbl>
#nicer labels
item_stats_leftism$nice_name = read_csv("data/pol_items.csv") %>% pull(nice_name2)
## Rows: 41 Columns: 9
## ── Column specification ────────────────────────────────────────────────────────
## Delimiter: ","
## chr (4): item, nice_name, rev, nice_name2
## dbl (5): item_i, loading, difficulty, discrimination, pass_rate
## 
## ℹ Use `spec()` to retrieve the full column specification for this data.
## ℹ Specify the column types or set `show_col_types = FALSE` to quiet this message.
#do metrics agree on which items are most important?
item_stats_leftism %>% select(starts_with("p_")) %>% cor_matrix()
##                  p_diag_r p_diag_r_inc p_symptoms_r p_symptoms_r_inc
## p_diag_r            1.000        0.940        0.784            0.711
## p_diag_r_inc        0.940        1.000        0.829            0.799
## p_symptoms_r        0.784        0.829        1.000            0.970
## p_symptoms_r_inc    0.711        0.799        0.970            1.000
#combined plot
patchwork::wrap_plots(
  item_stats_leftism %>% 
    GG_scatter("loading", "p_diag_r", case_names = "nice_name", text_size = 2) +
    coord_cartesian(xlim = c(0, 1)),

  item_stats_leftism %>% 
    GG_scatter("loading", "p_symptoms_r", case_names = "nice_name", text_size = 2) +
    coord_cartesian(xlim = c(0, 1)),
  
  item_stats_leftism %>% 
    GG_scatter("loading", "p_diag_r_inc", case_names = "nice_name", text_size = 2) +
    coord_cartesian(xlim = c(0, 1)),
  
  item_stats_leftism %>%
    GG_scatter("loading", "p_symptoms_r_inc", case_names = "nice_name", text_size = 2) +
    coord_cartesian(xlim = c(0, 1)),
  
  guides = "collect"
)
## `geom_smooth()` using formula = 'y ~ x'
## `geom_smooth()` using formula = 'y ~ x'
## `geom_smooth()` using formula = 'y ~ x'
## `geom_smooth()` using formula = 'y ~ x'

GG_save("figs/Jensen_method_leftism_p.png")
## `geom_smooth()` using formula = 'y ~ x'
## `geom_smooth()` using formula = 'y ~ x'
## `geom_smooth()` using formula = 'y ~ x'
## `geom_smooth()` using formula = 'y ~ x'
#items in top and bottom across methods
item_stats_leftism$r_mean = item_stats_leftism %>% select(starts_with("p_")) %>% rowMeans()

bind_rows(
  item_stats_leftism %>% arrange(r_mean) %>% head(5) %>% select(nice_name, loading, r_mean),
  item_stats_leftism %>% arrange(r_mean) %>% tail(5) %>% select(nice_name, loading, r_mean)
)

DIF

Leftism

All items
#DIF with all items
dif_irt_mh_all = DIF_test(
  items = mh_vars_num,
  model = 1,
  itemtype = mh_vars_options$itemtype,
  group = d$leftism_median_split,
  verbose = F
)
## There are 8 steps
## Step 1: Initial joint fit
## 
## Step 2: Initial MI fit
## 
## Step 3: Leave one out MI testing
## 
## Step 4: Fit without DIF items, liberal threshold
## 
## Step 5: Fit without DIF items, conservative threshold
## Warning: EM cycles terminated after 500 iterations.
## 
## Step 6: Fit with anchor items, liberal threshold
## 
## Step 7: Fit with anchor items, conservative threshold
## 
## Step 8: Get scores
#scale level gap and bias
SMD_matrix(d$p_all, d$leftism_median_split)
##       High   Low
## High    NA 0.294
## Low  0.294    NA
dif_irt_mh_all$effect_size_test
## $liberal
##           Effect Size  Value
## 1                STDS 0.7047
## 2                UTDS 4.6623
## 3              UETSDS 0.8072
## 4               ETSSD 0.0233
## 5         Starks.DTFR 0.7663
## 6               UDTFR 4.6890
## 7              UETSDN 0.8606
## 8 theta.of.max.test.D 2.5463
## 9           Test.Dmax 6.6793
## 
## $conservative
##           Effect Size Value
## 1                STDS 0.703
## 2                UTDS 1.316
## 3              UETSDS 0.703
## 4               ETSSD 0.023
## 5         Starks.DTFR 0.719
## 6               UDTFR 1.327
## 7              UETSDN 0.719
## 8 theta.of.max.test.D 2.607
## 9           Test.Dmax 4.562
#plot scale function
plot(
  dif_irt_mh_all$fits$anchor_liberal,
  type = "score"
)

#what items are biased?
dif_irt_mh_all$effect_size_items
## $liberal
##                                                                                                         SIDS
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               -0.064
## Most_of_the_time_I_feel_blue                                                                           0.000
## I_often_feel_as_if_things_were_not_real                                                                0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                       0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                              0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                   0.000
## Life_is_a_strain_for_me_much_of_the_time                                                               0.000
## I_have_strange_and_peculiar_thoughts                                                                   0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                0.057
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything              0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to      0.052
## At_times_I_think_I_am_no_good_at_all                                                                  -0.052
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                         0.000
## I_am_happy_most_of_the_time                                                                           -0.076
## I_very_seldom_have_spells_of_the_blues                                                                -0.036
## During_the_past_few_years_I_have_been_well_most_of_the_time                                           -0.032
## My_daily_life_is_full_of_things_that_keep_me_interested                                                0.000
## I_am_usually_calm_and_not_easily_upset                                                                 0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                               0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                       0.000
## I_am_liked_by_most_people_who_know_me                                                                  0.049
## I_am_not_easily_angered                                                                                0.000
## I_do_not_mind_meeting_strangers                                                                        0.000
## I_get_all_the_sympathy_I_should                                                                        0.000
## Little_interest_or_pleasure_in_doing_things                                                            0.000
## Feeling_down_depressed_or_hopeless                                                                     0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                     0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                0.181
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                           0.217
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 -0.143
## Feeling_panic_or_being_frightened                                                                      0.083
## Avoiding_situations_that_make_you_anxious                                                              0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                          0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                       0.124
## Thoughts_of_actually_hurting_yourself                                                                  0.135
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                   0.258
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking  0.239
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                          0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home           0.181
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                    0.166
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                         0.183
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories        0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                            0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                             0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                      0.132
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                               0.244
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                      -0.033
## Life_satisfaction                                                                                     -0.137
## Job_satisfaction                                                                                       0.000
## Social_satisfaction                                                                                   -0.158
## Romantic_satisfaction                                                                                 -0.245
## Mood_higher_means_better_mood                                                                         -0.067
## Anxiety_levels_higher_means_less_anxious                                                               0.192
## In_most_ways_my_life_is_close_to_my_ideal                                                             -0.192
## The_conditions_of_my_life_are_excellent                                                                0.000
## I_am_satisfied_with_my_life                                                                           -0.144
## So_far_I_have_gotten_the_important_things_I_want_in_life                                               0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                            -0.265
## Attention_deficit_hyperactivity_disorder_ADHD                                                         -0.062
## Alcohol_abuse                                                                                          0.000
## Non_alcohol_drug_abuse                                                                                 0.000
## Autism_spectrum_disorder_ASD                                                                           0.000
## Anti_social_personality_disorder                                                                       0.000
## Bipolarity                                                                                             0.000
## Borderline_Personality_Disorder                                                                        0.000
## Depression                                                                                             0.000
## General_Anxiety_Disorder_GAD                                                                          -0.068
## Obsessive_compulsive_disorder_OCD                                                                     -0.016
## Panic_disorder                                                                                         0.000
## Paranoia_Paranoid_personality_disorder                                                                 0.000
## Phobias_social                                                                                         0.000
## Specific_phobias                                                                                       0.000
## Post_traumatic_stress_disorder_PTSD                                                                    0.000
## Schizophrenia                                                                                          0.000
## Schizoid_personality_disorder                                                                          0.000
## Sleeping_disorders                                                                                     0.000
##                                                                                                        UIDS
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               0.080
## Most_of_the_time_I_feel_blue                                                                          0.000
## I_often_feel_as_if_things_were_not_real                                                               0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                      0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                             0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                  0.000
## Life_is_a_strain_for_me_much_of_the_time                                                              0.000
## I_have_strange_and_peculiar_thoughts                                                                  0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up               0.057
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything             0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to     0.052
## At_times_I_think_I_am_no_good_at_all                                                                  0.052
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                        0.000
## I_am_happy_most_of_the_time                                                                           0.095
## I_very_seldom_have_spells_of_the_blues                                                                0.108
## During_the_past_few_years_I_have_been_well_most_of_the_time                                           0.058
## My_daily_life_is_full_of_things_that_keep_me_interested                                               0.000
## I_am_usually_calm_and_not_easily_upset                                                                0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                              0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                      0.000
## I_am_liked_by_most_people_who_know_me                                                                 0.049
## I_am_not_easily_angered                                                                               0.000
## I_do_not_mind_meeting_strangers                                                                       0.000
## I_get_all_the_sympathy_I_should                                                                       0.000
## Little_interest_or_pleasure_in_doing_things                                                           0.000
## Feeling_down_depressed_or_hopeless                                                                    0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                    0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                               0.187
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                          0.218
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 0.146
## Feeling_panic_or_being_frightened                                                                     0.112
## Avoiding_situations_that_make_you_anxious                                                             0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                         0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                      0.125
## Thoughts_of_actually_hurting_yourself                                                                 0.135
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                  0.258
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking 0.239
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                         0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home          0.181
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                   0.166
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                        0.183
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories       0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                           0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                            0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                     0.140
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                              0.244
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                      0.067
## Life_satisfaction                                                                                     0.146
## Job_satisfaction                                                                                      0.000
## Social_satisfaction                                                                                   0.162
## Romantic_satisfaction                                                                                 0.245
## Mood_higher_means_better_mood                                                                         0.073
## Anxiety_levels_higher_means_less_anxious                                                              0.221
## In_most_ways_my_life_is_close_to_my_ideal                                                             0.232
## The_conditions_of_my_life_are_excellent                                                               0.000
## I_am_satisfied_with_my_life                                                                           0.211
## So_far_I_have_gotten_the_important_things_I_want_in_life                                              0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                            0.265
## Attention_deficit_hyperactivity_disorder_ADHD                                                         0.062
## Alcohol_abuse                                                                                         0.000
## Non_alcohol_drug_abuse                                                                                0.000
## Autism_spectrum_disorder_ASD                                                                          0.000
## Anti_social_personality_disorder                                                                      0.000
## Bipolarity                                                                                            0.000
## Borderline_Personality_Disorder                                                                       0.000
## Depression                                                                                            0.000
## General_Anxiety_Disorder_GAD                                                                          0.068
## Obsessive_compulsive_disorder_OCD                                                                     0.024
## Panic_disorder                                                                                        0.000
## Paranoia_Paranoid_personality_disorder                                                                0.000
## Phobias_social                                                                                        0.000
## Specific_phobias                                                                                      0.000
## Post_traumatic_stress_disorder_PTSD                                                                   0.000
## Schizophrenia                                                                                         0.000
## Schizoid_personality_disorder                                                                         0.000
## Sleeping_disorders                                                                                    0.000
##                                                                                                         SIDN
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               -0.061
## Most_of_the_time_I_feel_blue                                                                           0.000
## I_often_feel_as_if_things_were_not_real                                                                0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                       0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                              0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                   0.000
## Life_is_a_strain_for_me_much_of_the_time                                                               0.000
## I_have_strange_and_peculiar_thoughts                                                                   0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                0.054
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything              0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to      0.052
## At_times_I_think_I_am_no_good_at_all                                                                  -0.049
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                         0.000
## I_am_happy_most_of_the_time                                                                           -0.074
## I_very_seldom_have_spells_of_the_blues                                                                -0.033
## During_the_past_few_years_I_have_been_well_most_of_the_time                                           -0.033
## My_daily_life_is_full_of_things_that_keep_me_interested                                                0.000
## I_am_usually_calm_and_not_easily_upset                                                                 0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                               0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                       0.000
## I_am_liked_by_most_people_who_know_me                                                                  0.049
## I_am_not_easily_angered                                                                                0.000
## I_do_not_mind_meeting_strangers                                                                        0.000
## I_get_all_the_sympathy_I_should                                                                        0.000
## Little_interest_or_pleasure_in_doing_things                                                            0.000
## Feeling_down_depressed_or_hopeless                                                                     0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                     0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                0.180
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                           0.218
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 -0.138
## Feeling_panic_or_being_frightened                                                                      0.084
## Avoiding_situations_that_make_you_anxious                                                              0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                          0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                       0.124
## Thoughts_of_actually_hurting_yourself                                                                  0.138
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                   0.270
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking  0.250
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                          0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home           0.182
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                    0.165
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                         0.181
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories        0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                            0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                             0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                      0.135
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                               0.246
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                      -0.029
## Life_satisfaction                                                                                     -0.135
## Job_satisfaction                                                                                       0.000
## Social_satisfaction                                                                                   -0.155
## Romantic_satisfaction                                                                                 -0.241
## Mood_higher_means_better_mood                                                                         -0.068
## Anxiety_levels_higher_means_less_anxious                                                               0.194
## In_most_ways_my_life_is_close_to_my_ideal                                                             -0.188
## The_conditions_of_my_life_are_excellent                                                                0.000
## I_am_satisfied_with_my_life                                                                           -0.141
## So_far_I_have_gotten_the_important_things_I_want_in_life                                               0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                            -0.263
## Attention_deficit_hyperactivity_disorder_ADHD                                                         -0.063
## Alcohol_abuse                                                                                          0.000
## Non_alcohol_drug_abuse                                                                                 0.000
## Autism_spectrum_disorder_ASD                                                                           0.000
## Anti_social_personality_disorder                                                                       0.000
## Bipolarity                                                                                             0.000
## Borderline_Personality_Disorder                                                                        0.000
## Depression                                                                                             0.000
## General_Anxiety_Disorder_GAD                                                                          -0.068
## Obsessive_compulsive_disorder_OCD                                                                     -0.017
## Panic_disorder                                                                                         0.000
## Paranoia_Paranoid_personality_disorder                                                                 0.000
## Phobias_social                                                                                         0.000
## Specific_phobias                                                                                       0.000
## Post_traumatic_stress_disorder_PTSD                                                                    0.000
## Schizophrenia                                                                                          0.000
## Schizoid_personality_disorder                                                                          0.000
## Sleeping_disorders                                                                                     0.000
##                                                                                                        UIDN
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               0.079
## Most_of_the_time_I_feel_blue                                                                          0.000
## I_often_feel_as_if_things_were_not_real                                                               0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                      0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                             0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                  0.000
## Life_is_a_strain_for_me_much_of_the_time                                                              0.000
## I_have_strange_and_peculiar_thoughts                                                                  0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up               0.055
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything             0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to     0.052
## At_times_I_think_I_am_no_good_at_all                                                                  0.049
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                        0.000
## I_am_happy_most_of_the_time                                                                           0.094
## I_very_seldom_have_spells_of_the_blues                                                                0.109
## During_the_past_few_years_I_have_been_well_most_of_the_time                                           0.060
## My_daily_life_is_full_of_things_that_keep_me_interested                                               0.000
## I_am_usually_calm_and_not_easily_upset                                                                0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                              0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                      0.000
## I_am_liked_by_most_people_who_know_me                                                                 0.049
## I_am_not_easily_angered                                                                               0.000
## I_do_not_mind_meeting_strangers                                                                       0.000
## I_get_all_the_sympathy_I_should                                                                       0.000
## Little_interest_or_pleasure_in_doing_things                                                           0.000
## Feeling_down_depressed_or_hopeless                                                                    0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                    0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                               0.186
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                          0.219
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 0.143
## Feeling_panic_or_being_frightened                                                                     0.112
## Avoiding_situations_that_make_you_anxious                                                             0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                         0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                      0.125
## Thoughts_of_actually_hurting_yourself                                                                 0.138
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                  0.270
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking 0.251
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                         0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home          0.183
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                   0.165
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                        0.181
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories       0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                           0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                            0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                     0.144
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                              0.246
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                      0.071
## Life_satisfaction                                                                                     0.144
## Job_satisfaction                                                                                      0.000
## Social_satisfaction                                                                                   0.158
## Romantic_satisfaction                                                                                 0.241
## Mood_higher_means_better_mood                                                                         0.073
## Anxiety_levels_higher_means_less_anxious                                                              0.228
## In_most_ways_my_life_is_close_to_my_ideal                                                             0.231
## The_conditions_of_my_life_are_excellent                                                               0.000
## I_am_satisfied_with_my_life                                                                           0.214
## So_far_I_have_gotten_the_important_things_I_want_in_life                                              0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                            0.263
## Attention_deficit_hyperactivity_disorder_ADHD                                                         0.063
## Alcohol_abuse                                                                                         0.000
## Non_alcohol_drug_abuse                                                                                0.000
## Autism_spectrum_disorder_ASD                                                                          0.000
## Anti_social_personality_disorder                                                                      0.000
## Bipolarity                                                                                            0.000
## Borderline_Personality_Disorder                                                                       0.000
## Depression                                                                                            0.000
## General_Anxiety_Disorder_GAD                                                                          0.068
## Obsessive_compulsive_disorder_OCD                                                                     0.026
## Panic_disorder                                                                                        0.000
## Paranoia_Paranoid_personality_disorder                                                                0.000
## Phobias_social                                                                                        0.000
## Specific_phobias                                                                                      0.000
## Post_traumatic_stress_disorder_PTSD                                                                   0.000
## Schizophrenia                                                                                         0.000
## Schizoid_personality_disorder                                                                         0.000
## Sleeping_disorders                                                                                    0.000
##                                                                                                         ESSD
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               -0.233
## Most_of_the_time_I_feel_blue                                                                           0.000
## I_often_feel_as_if_things_were_not_real                                                                0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                       0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                              0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                   0.000
## Life_is_a_strain_for_me_much_of_the_time                                                               0.000
## I_have_strange_and_peculiar_thoughts                                                                   0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                0.230
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything              0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to      0.291
## At_times_I_think_I_am_no_good_at_all                                                                  -0.190
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                         0.000
## I_am_happy_most_of_the_time                                                                           -0.294
## I_very_seldom_have_spells_of_the_blues                                                                -0.141
## During_the_past_few_years_I_have_been_well_most_of_the_time                                           -0.168
## My_daily_life_is_full_of_things_that_keep_me_interested                                                0.000
## I_am_usually_calm_and_not_easily_upset                                                                 0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                               0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                       0.000
## I_am_liked_by_most_people_who_know_me                                                                  0.498
## I_am_not_easily_angered                                                                                0.000
## I_do_not_mind_meeting_strangers                                                                        0.000
## I_get_all_the_sympathy_I_should                                                                        0.000
## Little_interest_or_pleasure_in_doing_things                                                            0.000
## Feeling_down_depressed_or_hopeless                                                                     0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                     0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                0.367
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                           0.553
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 -0.166
## Feeling_panic_or_being_frightened                                                                      0.104
## Avoiding_situations_that_make_you_anxious                                                              0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                          0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                       0.184
## Thoughts_of_actually_hurting_yourself                                                                  0.263
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                   0.846
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking  0.804
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                          0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home           0.312
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                    0.257
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                         0.359
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories        0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                            0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                             0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                      0.654
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                               0.843
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                      -0.111
## Life_satisfaction                                                                                     -0.129
## Job_satisfaction                                                                                       0.000
## Social_satisfaction                                                                                   -0.152
## Romantic_satisfaction                                                                                 -0.253
## Mood_higher_means_better_mood                                                                         -0.062
## Anxiety_levels_higher_means_less_anxious                                                               0.243
## In_most_ways_my_life_is_close_to_my_ideal                                                             -0.169
## The_conditions_of_my_life_are_excellent                                                                0.000
## I_am_satisfied_with_my_life                                                                           -0.122
## So_far_I_have_gotten_the_important_things_I_want_in_life                                               0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                            -0.265
## Attention_deficit_hyperactivity_disorder_ADHD                                                         -1.117
## Alcohol_abuse                                                                                          0.000
## Non_alcohol_drug_abuse                                                                                 0.000
## Autism_spectrum_disorder_ASD                                                                           0.000
## Anti_social_personality_disorder                                                                       0.000
## Bipolarity                                                                                             0.000
## Borderline_Personality_Disorder                                                                        0.000
## Depression                                                                                             0.000
## General_Anxiety_Disorder_GAD                                                                          -0.524
## Obsessive_compulsive_disorder_OCD                                                                     -0.586
## Panic_disorder                                                                                         0.000
## Paranoia_Paranoid_personality_disorder                                                                 0.000
## Phobias_social                                                                                         0.000
## Specific_phobias                                                                                       0.000
## Post_traumatic_stress_disorder_PTSD                                                                    0.000
## Schizophrenia                                                                                          0.000
## Schizoid_personality_disorder                                                                          0.000
## Sleeping_disorders                                                                                     0.000
##                                                                                                       theta.of.max.D
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                                        0.007
## Most_of_the_time_I_feel_blue                                                                                  -1.344
## I_often_feel_as_if_things_were_not_real                                                                       -1.344
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                              -1.344
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                                     -1.344
## I_feel_that_I_have_often_been_punished_without_cause                                                          -1.344
## Life_is_a_strain_for_me_much_of_the_time                                                                      -1.344
## I_have_strange_and_peculiar_thoughts                                                                          -1.344
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                        0.898
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything                     -1.344
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to              1.323
## At_times_I_think_I_am_no_good_at_all                                                                           0.404
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                                -1.344
## I_am_happy_most_of_the_time                                                                                    0.954
## I_very_seldom_have_spells_of_the_blues                                                                         0.944
## During_the_past_few_years_I_have_been_well_most_of_the_time                                                    1.545
## My_daily_life_is_full_of_things_that_keep_me_interested                                                       -1.344
## I_am_usually_calm_and_not_easily_upset                                                                        -1.344
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                                      -1.344
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                              -1.344
## I_am_liked_by_most_people_who_know_me                                                                          1.836
## I_am_not_easily_angered                                                                                       -1.344
## I_do_not_mind_meeting_strangers                                                                               -1.344
## I_get_all_the_sympathy_I_should                                                                               -1.344
## Little_interest_or_pleasure_in_doing_things                                                                   -1.344
## Feeling_down_depressed_or_hopeless                                                                            -1.344
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                            -1.344
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                        2.546
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                                   2.546
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                         -0.612
## Feeling_panic_or_being_frightened                                                                              1.230
## Avoiding_situations_that_make_you_anxious                                                                     -1.344
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                                 -1.344
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                               1.323
## Thoughts_of_actually_hurting_yourself                                                                          1.499
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                           2.546
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking          2.546
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                                 -1.344
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home                   2.212
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                            1.472
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                                 1.230
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories               -1.344
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                                   -1.344
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                                    -1.344
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                              2.546
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                                       2.546
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                               2.546
## Life_satisfaction                                                                                              1.230
## Job_satisfaction                                                                                              -1.344
## Social_satisfaction                                                                                            1.011
## Romantic_satisfaction                                                                                          0.296
## Mood_higher_means_better_mood                                                                                  2.265
## Anxiety_levels_higher_means_less_anxious                                                                      -2.650
## In_most_ways_my_life_is_close_to_my_ideal                                                                      1.323
## The_conditions_of_my_life_are_excellent                                                                       -1.344
## I_am_satisfied_with_my_life                                                                                    1.307
## So_far_I_have_gotten_the_important_things_I_want_in_life                                                      -1.344
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                                    -0.163
## Attention_deficit_hyperactivity_disorder_ADHD                                                                  2.546
## Alcohol_abuse                                                                                                 -1.344
## Non_alcohol_drug_abuse                                                                                        -1.344
## Autism_spectrum_disorder_ASD                                                                                  -1.344
## Anti_social_personality_disorder                                                                              -1.344
## Bipolarity                                                                                                    -1.344
## Borderline_Personality_Disorder                                                                               -1.344
## Depression                                                                                                    -1.344
## General_Anxiety_Disorder_GAD                                                                                   1.958
## Obsessive_compulsive_disorder_OCD                                                                              2.546
## Panic_disorder                                                                                                -1.344
## Paranoia_Paranoid_personality_disorder                                                                        -1.344
## Phobias_social                                                                                                -1.344
## Specific_phobias                                                                                              -1.344
## Post_traumatic_stress_disorder_PTSD                                                                           -1.344
## Schizophrenia                                                                                                 -1.344
## Schizoid_personality_disorder                                                                                 -1.344
## Sleeping_disorders                                                                                            -1.344
##                                                                                                        max.D
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               -0.151
## Most_of_the_time_I_feel_blue                                                                           0.000
## I_often_feel_as_if_things_were_not_real                                                                0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                       0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                              0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                   0.000
## Life_is_a_strain_for_me_much_of_the_time                                                               0.000
## I_have_strange_and_peculiar_thoughts                                                                   0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                0.191
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything              0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to      0.185
## At_times_I_think_I_am_no_good_at_all                                                                  -0.104
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                         0.000
## I_am_happy_most_of_the_time                                                                           -0.312
## I_very_seldom_have_spells_of_the_blues                                                                -0.227
## During_the_past_few_years_I_have_been_well_most_of_the_time                                           -0.241
## My_daily_life_is_full_of_things_that_keep_me_interested                                                0.000
## I_am_usually_calm_and_not_easily_upset                                                                 0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                               0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                       0.000
## I_am_liked_by_most_people_who_know_me                                                                  0.160
## I_am_not_easily_angered                                                                                0.000
## I_do_not_mind_meeting_strangers                                                                        0.000
## I_get_all_the_sympathy_I_should                                                                        0.000
## Little_interest_or_pleasure_in_doing_things                                                            0.000
## Feeling_down_depressed_or_hopeless                                                                     0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                     0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                0.518
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                           0.779
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 -0.249
## Feeling_panic_or_being_frightened                                                                      0.426
## Avoiding_situations_that_make_you_anxious                                                              0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                          0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                       0.386
## Thoughts_of_actually_hurting_yourself                                                                  0.629
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                   1.968
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking  1.810
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                          0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home           0.664
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                    0.474
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                         0.453
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories        0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                            0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                             0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                      0.853
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                               0.911
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                       0.451
## Life_satisfaction                                                                                     -0.336
## Job_satisfaction                                                                                       0.000
## Social_satisfaction                                                                                   -0.241
## Romantic_satisfaction                                                                                 -0.293
## Mood_higher_means_better_mood                                                                         -0.220
## Anxiety_levels_higher_means_less_anxious                                                               0.489
## In_most_ways_my_life_is_close_to_my_ideal                                                             -0.549
## The_conditions_of_my_life_are_excellent                                                                0.000
## I_am_satisfied_with_my_life                                                                           -0.573
## So_far_I_have_gotten_the_important_things_I_want_in_life                                               0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                            -0.298
## Attention_deficit_hyperactivity_disorder_ADHD                                                         -0.231
## Alcohol_abuse                                                                                          0.000
## Non_alcohol_drug_abuse                                                                                 0.000
## Autism_spectrum_disorder_ASD                                                                           0.000
## Anti_social_personality_disorder                                                                       0.000
## Bipolarity                                                                                             0.000
## Borderline_Personality_Disorder                                                                        0.000
## Depression                                                                                             0.000
## General_Anxiety_Disorder_GAD                                                                          -0.188
## Obsessive_compulsive_disorder_OCD                                                                     -0.281
## Panic_disorder                                                                                         0.000
## Paranoia_Paranoid_personality_disorder                                                                 0.000
## Phobias_social                                                                                         0.000
## Specific_phobias                                                                                       0.000
## Post_traumatic_stress_disorder_PTSD                                                                    0.000
## Schizophrenia                                                                                          0.000
## Schizoid_personality_disorder                                                                          0.000
## Sleeping_disorders                                                                                     0.000
##                                                                                                       mean.ES.foc
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                                     0.218
## Most_of_the_time_I_feel_blue                                                                                0.192
## I_often_feel_as_if_things_were_not_real                                                                     0.140
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                            0.200
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                                   0.230
## I_feel_that_I_have_often_been_punished_without_cause                                                        0.195
## Life_is_a_strain_for_me_much_of_the_time                                                                    0.254
## I_have_strange_and_peculiar_thoughts                                                                        0.252
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                     0.219
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything                   0.197
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to           0.170
## At_times_I_think_I_am_no_good_at_all                                                                        0.227
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                              0.284
## I_am_happy_most_of_the_time                                                                                 0.205
## I_very_seldom_have_spells_of_the_blues                                                                      0.373
## During_the_past_few_years_I_have_been_well_most_of_the_time                                                 0.185
## My_daily_life_is_full_of_things_that_keep_me_interested                                                     0.215
## I_am_usually_calm_and_not_easily_upset                                                                      0.162
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                                    0.164
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                            0.355
## I_am_liked_by_most_people_who_know_me                                                                       0.107
## I_am_not_easily_angered                                                                                     0.211
## I_do_not_mind_meeting_strangers                                                                             0.262
## I_get_all_the_sympathy_I_should                                                                             0.227
## Little_interest_or_pleasure_in_doing_things                                                                 1.024
## Feeling_down_depressed_or_hopeless                                                                          0.974
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                          0.946
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                     1.053
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                                0.673
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                       0.977
## Feeling_panic_or_being_frightened                                                                           0.700
## Avoiding_situations_that_make_you_anxious                                                                   1.097
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                               0.899
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                            0.641
## Thoughts_of_actually_hurting_yourself                                                                       0.367
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                        0.355
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking       0.344
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                               1.154
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home                0.633
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                         0.606
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                              0.523
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories             0.461
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                                 0.573
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                                  0.715
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                           0.469
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                                    0.716
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                            0.359
## Life_satisfaction                                                                                           1.908
## Job_satisfaction                                                                                            2.489
## Social_satisfaction                                                                                         2.274
## Romantic_satisfaction                                                                                       2.256
## Mood_higher_means_better_mood                                                                               1.946
## Anxiety_levels_higher_means_less_anxious                                                                    2.844
## In_most_ways_my_life_is_close_to_my_ideal                                                                   2.420
## The_conditions_of_my_life_are_excellent                                                                     2.459
## I_am_satisfied_with_my_life                                                                                 2.145
## So_far_I_have_gotten_the_important_things_I_want_in_life                                                    2.205
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                                  2.973
## Attention_deficit_hyperactivity_disorder_ADHD                                                               0.065
## Alcohol_abuse                                                                                               0.042
## Non_alcohol_drug_abuse                                                                                      0.017
## Autism_spectrum_disorder_ASD                                                                                0.027
## Anti_social_personality_disorder                                                                            0.011
## Bipolarity                                                                                                  0.035
## Borderline_Personality_Disorder                                                                             0.015
## Depression                                                                                                  0.221
## General_Anxiety_Disorder_GAD                                                                                0.148
## Obsessive_compulsive_disorder_OCD                                                                           0.025
## Panic_disorder                                                                                              0.044
## Paranoia_Paranoid_personality_disorder                                                                      0.002
## Phobias_social                                                                                              0.014
## Specific_phobias                                                                                            0.014
## Post_traumatic_stress_disorder_PTSD                                                                         0.062
## Schizophrenia                                                                                               0.002
## Schizoid_personality_disorder                                                                               0.002
## Sleeping_disorders                                                                                          0.078
##                                                                                                       mean.ES.ref
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                                     0.282
## Most_of_the_time_I_feel_blue                                                                                0.192
## I_often_feel_as_if_things_were_not_real                                                                     0.140
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                            0.200
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                                   0.230
## I_feel_that_I_have_often_been_punished_without_cause                                                        0.195
## Life_is_a_strain_for_me_much_of_the_time                                                                    0.254
## I_have_strange_and_peculiar_thoughts                                                                        0.252
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                     0.162
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything                   0.197
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to           0.118
## At_times_I_think_I_am_no_good_at_all                                                                        0.278
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                              0.284
## I_am_happy_most_of_the_time                                                                                 0.281
## I_very_seldom_have_spells_of_the_blues                                                                      0.409
## During_the_past_few_years_I_have_been_well_most_of_the_time                                                 0.217
## My_daily_life_is_full_of_things_that_keep_me_interested                                                     0.215
## I_am_usually_calm_and_not_easily_upset                                                                      0.162
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                                    0.164
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                            0.355
## I_am_liked_by_most_people_who_know_me                                                                       0.059
## I_am_not_easily_angered                                                                                     0.211
## I_do_not_mind_meeting_strangers                                                                             0.262
## I_get_all_the_sympathy_I_should                                                                             0.227
## Little_interest_or_pleasure_in_doing_things                                                                 1.024
## Feeling_down_depressed_or_hopeless                                                                          0.974
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                          0.946
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                     0.873
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                                0.456
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                       1.120
## Feeling_panic_or_being_frightened                                                                           0.617
## Avoiding_situations_that_make_you_anxious                                                                   1.097
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                               0.899
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                            0.517
## Thoughts_of_actually_hurting_yourself                                                                       0.232
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                        0.096
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking       0.105
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                               1.154
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home                0.452
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                         0.440
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                              0.340
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories             0.461
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                                 0.573
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                                  0.715
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                           0.338
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                                    0.472
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                            0.392
## Life_satisfaction                                                                                           2.046
## Job_satisfaction                                                                                            2.489
## Social_satisfaction                                                                                         2.432
## Romantic_satisfaction                                                                                       2.500
## Mood_higher_means_better_mood                                                                               2.013
## Anxiety_levels_higher_means_less_anxious                                                                    2.652
## In_most_ways_my_life_is_close_to_my_ideal                                                                   2.612
## The_conditions_of_my_life_are_excellent                                                                     2.459
## I_am_satisfied_with_my_life                                                                                 2.289
## So_far_I_have_gotten_the_important_things_I_want_in_life                                                    2.205
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                                  3.239
## Attention_deficit_hyperactivity_disorder_ADHD                                                               0.127
## Alcohol_abuse                                                                                               0.042
## Non_alcohol_drug_abuse                                                                                      0.017
## Autism_spectrum_disorder_ASD                                                                                0.027
## Anti_social_personality_disorder                                                                            0.011
## Bipolarity                                                                                                  0.035
## Borderline_Personality_Disorder                                                                             0.015
## Depression                                                                                                  0.221
## General_Anxiety_Disorder_GAD                                                                                0.216
## Obsessive_compulsive_disorder_OCD                                                                           0.040
## Panic_disorder                                                                                              0.044
## Paranoia_Paranoid_personality_disorder                                                                      0.002
## Phobias_social                                                                                              0.014
## Specific_phobias                                                                                            0.014
## Post_traumatic_stress_disorder_PTSD                                                                         0.062
## Schizophrenia                                                                                               0.002
## Schizoid_personality_disorder                                                                               0.002
## Sleeping_disorders                                                                                          0.078
## 
## $conservative
##                                                                                                         SIDS
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               -0.065
## Most_of_the_time_I_feel_blue                                                                           0.000
## I_often_feel_as_if_things_were_not_real                                                                0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                       0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                              0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                   0.000
## Life_is_a_strain_for_me_much_of_the_time                                                               0.000
## I_have_strange_and_peculiar_thoughts                                                                   0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                0.000
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything              0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to      0.000
## At_times_I_think_I_am_no_good_at_all                                                                   0.000
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                         0.000
## I_am_happy_most_of_the_time                                                                           -0.079
## I_very_seldom_have_spells_of_the_blues                                                                -0.035
## During_the_past_few_years_I_have_been_well_most_of_the_time                                            0.000
## My_daily_life_is_full_of_things_that_keep_me_interested                                                0.000
## I_am_usually_calm_and_not_easily_upset                                                                 0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                               0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                       0.000
## I_am_liked_by_most_people_who_know_me                                                                  0.000
## I_am_not_easily_angered                                                                                0.000
## I_do_not_mind_meeting_strangers                                                                        0.000
## I_get_all_the_sympathy_I_should                                                                        0.000
## Little_interest_or_pleasure_in_doing_things                                                            0.000
## Feeling_down_depressed_or_hopeless                                                                     0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                     0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                0.000
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                           0.217
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                  0.000
## Feeling_panic_or_being_frightened                                                                      0.000
## Avoiding_situations_that_make_you_anxious                                                              0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                          0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                       0.000
## Thoughts_of_actually_hurting_yourself                                                                  0.000
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                   0.256
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking  0.237
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                          0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home           0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                    0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                         0.000
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories        0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                            0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                             0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                      0.000
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                               0.245
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                       0.000
## Life_satisfaction                                                                                      0.000
## Job_satisfaction                                                                                       0.000
## Social_satisfaction                                                                                    0.000
## Romantic_satisfaction                                                                                  0.000
## Mood_higher_means_better_mood                                                                         -0.073
## Anxiety_levels_higher_means_less_anxious                                                               0.000
## In_most_ways_my_life_is_close_to_my_ideal                                                              0.000
## The_conditions_of_my_life_are_excellent                                                                0.000
## I_am_satisfied_with_my_life                                                                            0.000
## So_far_I_have_gotten_the_important_things_I_want_in_life                                               0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                             0.000
## Attention_deficit_hyperactivity_disorder_ADHD                                                          0.000
## Alcohol_abuse                                                                                          0.000
## Non_alcohol_drug_abuse                                                                                 0.000
## Autism_spectrum_disorder_ASD                                                                           0.000
## Anti_social_personality_disorder                                                                       0.000
## Bipolarity                                                                                             0.000
## Borderline_Personality_Disorder                                                                        0.000
## Depression                                                                                             0.000
## General_Anxiety_Disorder_GAD                                                                           0.000
## Obsessive_compulsive_disorder_OCD                                                                      0.000
## Panic_disorder                                                                                         0.000
## Paranoia_Paranoid_personality_disorder                                                                 0.000
## Phobias_social                                                                                         0.000
## Specific_phobias                                                                                       0.000
## Post_traumatic_stress_disorder_PTSD                                                                    0.000
## Schizophrenia                                                                                          0.000
## Schizoid_personality_disorder                                                                          0.000
## Sleeping_disorders                                                                                     0.000
##                                                                                                        UIDS
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               0.076
## Most_of_the_time_I_feel_blue                                                                          0.000
## I_often_feel_as_if_things_were_not_real                                                               0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                      0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                             0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                  0.000
## Life_is_a_strain_for_me_much_of_the_time                                                              0.000
## I_have_strange_and_peculiar_thoughts                                                                  0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up               0.000
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything             0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to     0.000
## At_times_I_think_I_am_no_good_at_all                                                                  0.000
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                        0.000
## I_am_happy_most_of_the_time                                                                           0.096
## I_very_seldom_have_spells_of_the_blues                                                                0.111
## During_the_past_few_years_I_have_been_well_most_of_the_time                                           0.000
## My_daily_life_is_full_of_things_that_keep_me_interested                                               0.000
## I_am_usually_calm_and_not_easily_upset                                                                0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                              0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                      0.000
## I_am_liked_by_most_people_who_know_me                                                                 0.000
## I_am_not_easily_angered                                                                               0.000
## I_do_not_mind_meeting_strangers                                                                       0.000
## I_get_all_the_sympathy_I_should                                                                       0.000
## Little_interest_or_pleasure_in_doing_things                                                           0.000
## Feeling_down_depressed_or_hopeless                                                                    0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                    0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                               0.000
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                          0.217
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 0.000
## Feeling_panic_or_being_frightened                                                                     0.000
## Avoiding_situations_that_make_you_anxious                                                             0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                         0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                      0.000
## Thoughts_of_actually_hurting_yourself                                                                 0.000
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                  0.256
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking 0.237
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                         0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home          0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                   0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                        0.000
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories       0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                           0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                            0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                     0.000
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                              0.245
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                      0.000
## Life_satisfaction                                                                                     0.000
## Job_satisfaction                                                                                      0.000
## Social_satisfaction                                                                                   0.000
## Romantic_satisfaction                                                                                 0.000
## Mood_higher_means_better_mood                                                                         0.078
## Anxiety_levels_higher_means_less_anxious                                                              0.000
## In_most_ways_my_life_is_close_to_my_ideal                                                             0.000
## The_conditions_of_my_life_are_excellent                                                               0.000
## I_am_satisfied_with_my_life                                                                           0.000
## So_far_I_have_gotten_the_important_things_I_want_in_life                                              0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                            0.000
## Attention_deficit_hyperactivity_disorder_ADHD                                                         0.000
## Alcohol_abuse                                                                                         0.000
## Non_alcohol_drug_abuse                                                                                0.000
## Autism_spectrum_disorder_ASD                                                                          0.000
## Anti_social_personality_disorder                                                                      0.000
## Bipolarity                                                                                            0.000
## Borderline_Personality_Disorder                                                                       0.000
## Depression                                                                                            0.000
## General_Anxiety_Disorder_GAD                                                                          0.000
## Obsessive_compulsive_disorder_OCD                                                                     0.000
## Panic_disorder                                                                                        0.000
## Paranoia_Paranoid_personality_disorder                                                                0.000
## Phobias_social                                                                                        0.000
## Specific_phobias                                                                                      0.000
## Post_traumatic_stress_disorder_PTSD                                                                   0.000
## Schizophrenia                                                                                         0.000
## Schizoid_personality_disorder                                                                         0.000
## Sleeping_disorders                                                                                    0.000
##                                                                                                         SIDN
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               -0.064
## Most_of_the_time_I_feel_blue                                                                           0.000
## I_often_feel_as_if_things_were_not_real                                                                0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                       0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                              0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                   0.000
## Life_is_a_strain_for_me_much_of_the_time                                                               0.000
## I_have_strange_and_peculiar_thoughts                                                                   0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                0.000
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything              0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to      0.000
## At_times_I_think_I_am_no_good_at_all                                                                   0.000
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                         0.000
## I_am_happy_most_of_the_time                                                                           -0.077
## I_very_seldom_have_spells_of_the_blues                                                                -0.033
## During_the_past_few_years_I_have_been_well_most_of_the_time                                            0.000
## My_daily_life_is_full_of_things_that_keep_me_interested                                                0.000
## I_am_usually_calm_and_not_easily_upset                                                                 0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                               0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                       0.000
## I_am_liked_by_most_people_who_know_me                                                                  0.000
## I_am_not_easily_angered                                                                                0.000
## I_do_not_mind_meeting_strangers                                                                        0.000
## I_get_all_the_sympathy_I_should                                                                        0.000
## Little_interest_or_pleasure_in_doing_things                                                            0.000
## Feeling_down_depressed_or_hopeless                                                                     0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                     0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                0.000
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                           0.217
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                  0.000
## Feeling_panic_or_being_frightened                                                                      0.000
## Avoiding_situations_that_make_you_anxious                                                              0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                          0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                       0.000
## Thoughts_of_actually_hurting_yourself                                                                  0.000
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                   0.262
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking  0.242
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                          0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home           0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                    0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                         0.000
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories        0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                            0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                             0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                      0.000
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                               0.246
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                       0.000
## Life_satisfaction                                                                                      0.000
## Job_satisfaction                                                                                       0.000
## Social_satisfaction                                                                                    0.000
## Romantic_satisfaction                                                                                  0.000
## Mood_higher_means_better_mood                                                                         -0.074
## Anxiety_levels_higher_means_less_anxious                                                               0.000
## In_most_ways_my_life_is_close_to_my_ideal                                                              0.000
## The_conditions_of_my_life_are_excellent                                                                0.000
## I_am_satisfied_with_my_life                                                                            0.000
## So_far_I_have_gotten_the_important_things_I_want_in_life                                               0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                             0.000
## Attention_deficit_hyperactivity_disorder_ADHD                                                          0.000
## Alcohol_abuse                                                                                          0.000
## Non_alcohol_drug_abuse                                                                                 0.000
## Autism_spectrum_disorder_ASD                                                                           0.000
## Anti_social_personality_disorder                                                                       0.000
## Bipolarity                                                                                             0.000
## Borderline_Personality_Disorder                                                                        0.000
## Depression                                                                                             0.000
## General_Anxiety_Disorder_GAD                                                                           0.000
## Obsessive_compulsive_disorder_OCD                                                                      0.000
## Panic_disorder                                                                                         0.000
## Paranoia_Paranoid_personality_disorder                                                                 0.000
## Phobias_social                                                                                         0.000
## Specific_phobias                                                                                       0.000
## Post_traumatic_stress_disorder_PTSD                                                                    0.000
## Schizophrenia                                                                                          0.000
## Schizoid_personality_disorder                                                                          0.000
## Sleeping_disorders                                                                                     0.000
##                                                                                                        UIDN
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               0.076
## Most_of_the_time_I_feel_blue                                                                          0.000
## I_often_feel_as_if_things_were_not_real                                                               0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                      0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                             0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                  0.000
## Life_is_a_strain_for_me_much_of_the_time                                                              0.000
## I_have_strange_and_peculiar_thoughts                                                                  0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up               0.000
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything             0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to     0.000
## At_times_I_think_I_am_no_good_at_all                                                                  0.000
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                        0.000
## I_am_happy_most_of_the_time                                                                           0.094
## I_very_seldom_have_spells_of_the_blues                                                                0.111
## During_the_past_few_years_I_have_been_well_most_of_the_time                                           0.000
## My_daily_life_is_full_of_things_that_keep_me_interested                                               0.000
## I_am_usually_calm_and_not_easily_upset                                                                0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                              0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                      0.000
## I_am_liked_by_most_people_who_know_me                                                                 0.000
## I_am_not_easily_angered                                                                               0.000
## I_do_not_mind_meeting_strangers                                                                       0.000
## I_get_all_the_sympathy_I_should                                                                       0.000
## Little_interest_or_pleasure_in_doing_things                                                           0.000
## Feeling_down_depressed_or_hopeless                                                                    0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                    0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                               0.000
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                          0.217
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 0.000
## Feeling_panic_or_being_frightened                                                                     0.000
## Avoiding_situations_that_make_you_anxious                                                             0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                         0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                      0.000
## Thoughts_of_actually_hurting_yourself                                                                 0.000
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                  0.262
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking 0.242
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                         0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home          0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                   0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                        0.000
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories       0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                           0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                            0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                     0.000
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                              0.246
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                      0.000
## Life_satisfaction                                                                                     0.000
## Job_satisfaction                                                                                      0.000
## Social_satisfaction                                                                                   0.000
## Romantic_satisfaction                                                                                 0.000
## Mood_higher_means_better_mood                                                                         0.078
## Anxiety_levels_higher_means_less_anxious                                                              0.000
## In_most_ways_my_life_is_close_to_my_ideal                                                             0.000
## The_conditions_of_my_life_are_excellent                                                               0.000
## I_am_satisfied_with_my_life                                                                           0.000
## So_far_I_have_gotten_the_important_things_I_want_in_life                                              0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                            0.000
## Attention_deficit_hyperactivity_disorder_ADHD                                                         0.000
## Alcohol_abuse                                                                                         0.000
## Non_alcohol_drug_abuse                                                                                0.000
## Autism_spectrum_disorder_ASD                                                                          0.000
## Anti_social_personality_disorder                                                                      0.000
## Bipolarity                                                                                            0.000
## Borderline_Personality_Disorder                                                                       0.000
## Depression                                                                                            0.000
## General_Anxiety_Disorder_GAD                                                                          0.000
## Obsessive_compulsive_disorder_OCD                                                                     0.000
## Panic_disorder                                                                                        0.000
## Paranoia_Paranoid_personality_disorder                                                                0.000
## Phobias_social                                                                                        0.000
## Specific_phobias                                                                                      0.000
## Post_traumatic_stress_disorder_PTSD                                                                   0.000
## Schizophrenia                                                                                         0.000
## Schizoid_personality_disorder                                                                         0.000
## Sleeping_disorders                                                                                    0.000
##                                                                                                         ESSD
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               -0.235
## Most_of_the_time_I_feel_blue                                                                           0.000
## I_often_feel_as_if_things_were_not_real                                                                0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                       0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                              0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                   0.000
## Life_is_a_strain_for_me_much_of_the_time                                                               0.000
## I_have_strange_and_peculiar_thoughts                                                                   0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                0.000
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything              0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to      0.000
## At_times_I_think_I_am_no_good_at_all                                                                   0.000
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                         0.000
## I_am_happy_most_of_the_time                                                                           -0.302
## I_very_seldom_have_spells_of_the_blues                                                                -0.138
## During_the_past_few_years_I_have_been_well_most_of_the_time                                            0.000
## My_daily_life_is_full_of_things_that_keep_me_interested                                                0.000
## I_am_usually_calm_and_not_easily_upset                                                                 0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                               0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                       0.000
## I_am_liked_by_most_people_who_know_me                                                                  0.000
## I_am_not_easily_angered                                                                                0.000
## I_do_not_mind_meeting_strangers                                                                        0.000
## I_get_all_the_sympathy_I_should                                                                        0.000
## Little_interest_or_pleasure_in_doing_things                                                            0.000
## Feeling_down_depressed_or_hopeless                                                                     0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                     0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                0.000
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                           0.558
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                  0.000
## Feeling_panic_or_being_frightened                                                                      0.000
## Avoiding_situations_that_make_you_anxious                                                              0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                          0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                       0.000
## Thoughts_of_actually_hurting_yourself                                                                  0.000
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                   0.872
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking  0.827
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                          0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home           0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                    0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                         0.000
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories        0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                            0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                             0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                      0.000
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                               0.846
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                       0.000
## Life_satisfaction                                                                                      0.000
## Job_satisfaction                                                                                       0.000
## Social_satisfaction                                                                                    0.000
## Romantic_satisfaction                                                                                  0.000
## Mood_higher_means_better_mood                                                                         -0.066
## Anxiety_levels_higher_means_less_anxious                                                               0.000
## In_most_ways_my_life_is_close_to_my_ideal                                                              0.000
## The_conditions_of_my_life_are_excellent                                                                0.000
## I_am_satisfied_with_my_life                                                                            0.000
## So_far_I_have_gotten_the_important_things_I_want_in_life                                               0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                             0.000
## Attention_deficit_hyperactivity_disorder_ADHD                                                          0.000
## Alcohol_abuse                                                                                          0.000
## Non_alcohol_drug_abuse                                                                                 0.000
## Autism_spectrum_disorder_ASD                                                                           0.000
## Anti_social_personality_disorder                                                                       0.000
## Bipolarity                                                                                             0.000
## Borderline_Personality_Disorder                                                                        0.000
## Depression                                                                                             0.000
## General_Anxiety_Disorder_GAD                                                                           0.000
## Obsessive_compulsive_disorder_OCD                                                                      0.000
## Panic_disorder                                                                                         0.000
## Paranoia_Paranoid_personality_disorder                                                                 0.000
## Phobias_social                                                                                         0.000
## Specific_phobias                                                                                       0.000
## Post_traumatic_stress_disorder_PTSD                                                                    0.000
## Schizophrenia                                                                                          0.000
## Schizoid_personality_disorder                                                                          0.000
## Sleeping_disorders                                                                                     0.000
##                                                                                                       theta.of.max.D
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                                        0.038
## Most_of_the_time_I_feel_blue                                                                                  -1.336
## I_often_feel_as_if_things_were_not_real                                                                       -1.336
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                              -1.336
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                                     -1.336
## I_feel_that_I_have_often_been_punished_without_cause                                                          -1.336
## Life_is_a_strain_for_me_much_of_the_time                                                                      -1.336
## I_have_strange_and_peculiar_thoughts                                                                          -1.336
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                       -1.336
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything                     -1.336
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to             -1.336
## At_times_I_think_I_am_no_good_at_all                                                                          -1.336
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                                -1.336
## I_am_happy_most_of_the_time                                                                                    0.953
## I_very_seldom_have_spells_of_the_blues                                                                         0.951
## During_the_past_few_years_I_have_been_well_most_of_the_time                                                   -1.336
## My_daily_life_is_full_of_things_that_keep_me_interested                                                       -1.336
## I_am_usually_calm_and_not_easily_upset                                                                        -1.336
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                                      -1.336
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                              -1.336
## I_am_liked_by_most_people_who_know_me                                                                         -1.336
## I_am_not_easily_angered                                                                                       -1.336
## I_do_not_mind_meeting_strangers                                                                               -1.336
## I_get_all_the_sympathy_I_should                                                                               -1.336
## Little_interest_or_pleasure_in_doing_things                                                                   -1.336
## Feeling_down_depressed_or_hopeless                                                                            -1.336
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                            -1.336
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                       -1.336
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                                   2.607
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                         -1.336
## Feeling_panic_or_being_frightened                                                                             -1.336
## Avoiding_situations_that_make_you_anxious                                                                     -1.336
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                                 -1.336
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                              -1.336
## Thoughts_of_actually_hurting_yourself                                                                         -1.336
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                           2.607
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking          2.607
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                                 -1.336
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home                  -1.336
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                           -1.336
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                                -1.336
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories               -1.336
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                                   -1.336
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                                    -1.336
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                             -1.336
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                                       2.607
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                              -1.336
## Life_satisfaction                                                                                             -1.336
## Job_satisfaction                                                                                              -1.336
## Social_satisfaction                                                                                           -1.336
## Romantic_satisfaction                                                                                         -1.336
## Mood_higher_means_better_mood                                                                                  2.288
## Anxiety_levels_higher_means_less_anxious                                                                      -1.336
## In_most_ways_my_life_is_close_to_my_ideal                                                                     -1.336
## The_conditions_of_my_life_are_excellent                                                                       -1.336
## I_am_satisfied_with_my_life                                                                                   -1.336
## So_far_I_have_gotten_the_important_things_I_want_in_life                                                      -1.336
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                                    -1.336
## Attention_deficit_hyperactivity_disorder_ADHD                                                                 -1.336
## Alcohol_abuse                                                                                                 -1.336
## Non_alcohol_drug_abuse                                                                                        -1.336
## Autism_spectrum_disorder_ASD                                                                                  -1.336
## Anti_social_personality_disorder                                                                              -1.336
## Bipolarity                                                                                                    -1.336
## Borderline_Personality_Disorder                                                                               -1.336
## Depression                                                                                                    -1.336
## General_Anxiety_Disorder_GAD                                                                                  -1.336
## Obsessive_compulsive_disorder_OCD                                                                             -1.336
## Panic_disorder                                                                                                -1.336
## Paranoia_Paranoid_personality_disorder                                                                        -1.336
## Phobias_social                                                                                                -1.336
## Specific_phobias                                                                                              -1.336
## Post_traumatic_stress_disorder_PTSD                                                                           -1.336
## Schizophrenia                                                                                                 -1.336
## Schizoid_personality_disorder                                                                                 -1.336
## Sleeping_disorders                                                                                            -1.336
##                                                                                                        max.D
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               -0.149
## Most_of_the_time_I_feel_blue                                                                           0.000
## I_often_feel_as_if_things_were_not_real                                                                0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                       0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                              0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                   0.000
## Life_is_a_strain_for_me_much_of_the_time                                                               0.000
## I_have_strange_and_peculiar_thoughts                                                                   0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                0.000
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything              0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to      0.000
## At_times_I_think_I_am_no_good_at_all                                                                   0.000
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                         0.000
## I_am_happy_most_of_the_time                                                                           -0.311
## I_very_seldom_have_spells_of_the_blues                                                                -0.230
## During_the_past_few_years_I_have_been_well_most_of_the_time                                            0.000
## My_daily_life_is_full_of_things_that_keep_me_interested                                                0.000
## I_am_usually_calm_and_not_easily_upset                                                                 0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                               0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                       0.000
## I_am_liked_by_most_people_who_know_me                                                                  0.000
## I_am_not_easily_angered                                                                                0.000
## I_do_not_mind_meeting_strangers                                                                        0.000
## I_get_all_the_sympathy_I_should                                                                        0.000
## Little_interest_or_pleasure_in_doing_things                                                            0.000
## Feeling_down_depressed_or_hopeless                                                                     0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                     0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                0.000
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                           0.630
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                  0.000
## Feeling_panic_or_being_frightened                                                                      0.000
## Avoiding_situations_that_make_you_anxious                                                              0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                          0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                       0.000
## Thoughts_of_actually_hurting_yourself                                                                  0.000
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                   1.773
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking  1.635
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                          0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home           0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                    0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                         0.000
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories        0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                            0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                             0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                      0.000
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                               0.847
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                       0.000
## Life_satisfaction                                                                                      0.000
## Job_satisfaction                                                                                       0.000
## Social_satisfaction                                                                                    0.000
## Romantic_satisfaction                                                                                  0.000
## Mood_higher_means_better_mood                                                                         -0.207
## Anxiety_levels_higher_means_less_anxious                                                               0.000
## In_most_ways_my_life_is_close_to_my_ideal                                                              0.000
## The_conditions_of_my_life_are_excellent                                                                0.000
## I_am_satisfied_with_my_life                                                                            0.000
## So_far_I_have_gotten_the_important_things_I_want_in_life                                               0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                             0.000
## Attention_deficit_hyperactivity_disorder_ADHD                                                          0.000
## Alcohol_abuse                                                                                          0.000
## Non_alcohol_drug_abuse                                                                                 0.000
## Autism_spectrum_disorder_ASD                                                                           0.000
## Anti_social_personality_disorder                                                                       0.000
## Bipolarity                                                                                             0.000
## Borderline_Personality_Disorder                                                                        0.000
## Depression                                                                                             0.000
## General_Anxiety_Disorder_GAD                                                                           0.000
## Obsessive_compulsive_disorder_OCD                                                                      0.000
## Panic_disorder                                                                                         0.000
## Paranoia_Paranoid_personality_disorder                                                                 0.000
## Phobias_social                                                                                         0.000
## Specific_phobias                                                                                       0.000
## Post_traumatic_stress_disorder_PTSD                                                                    0.000
## Schizophrenia                                                                                          0.000
## Schizoid_personality_disorder                                                                          0.000
## Sleeping_disorders                                                                                     0.000
##                                                                                                       mean.ES.foc
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                                     0.218
## Most_of_the_time_I_feel_blue                                                                                0.194
## I_often_feel_as_if_things_were_not_real                                                                     0.142
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                            0.202
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                                   0.231
## I_feel_that_I_have_often_been_punished_without_cause                                                        0.197
## Life_is_a_strain_for_me_much_of_the_time                                                                    0.256
## I_have_strange_and_peculiar_thoughts                                                                        0.253
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                     0.189
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything                   0.198
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to           0.142
## At_times_I_think_I_am_no_good_at_all                                                                        0.255
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                              0.285
## I_am_happy_most_of_the_time                                                                                 0.205
## I_very_seldom_have_spells_of_the_blues                                                                      0.373
## During_the_past_few_years_I_have_been_well_most_of_the_time                                                 0.207
## My_daily_life_is_full_of_things_that_keep_me_interested                                                     0.216
## I_am_usually_calm_and_not_easily_upset                                                                      0.163
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                                    0.166
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                            0.355
## I_am_liked_by_most_people_who_know_me                                                                       0.082
## I_am_not_easily_angered                                                                                     0.212
## I_do_not_mind_meeting_strangers                                                                             0.262
## I_get_all_the_sympathy_I_should                                                                             0.227
## Little_interest_or_pleasure_in_doing_things                                                                 1.027
## Feeling_down_depressed_or_hopeless                                                                          0.978
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                          0.949
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                     0.960
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                                0.674
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                       1.047
## Feeling_panic_or_being_frightened                                                                           0.656
## Avoiding_situations_that_make_you_anxious                                                                   1.100
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                               0.902
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                            0.579
## Thoughts_of_actually_hurting_yourself                                                                       0.294
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                        0.354
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking       0.343
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                               1.158
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home                0.537
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                         0.521
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                              0.428
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories             0.467
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                                 0.581
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                                  0.721
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                           0.395
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                                    0.717
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                            0.375
## Life_satisfaction                                                                                           1.988
## Job_satisfaction                                                                                            2.489
## Social_satisfaction                                                                                         2.357
## Romantic_satisfaction                                                                                       2.379
## Mood_higher_means_better_mood                                                                               1.944
## Anxiety_levels_higher_means_less_anxious                                                                    2.752
## In_most_ways_my_life_is_close_to_my_ideal                                                                   2.534
## The_conditions_of_my_life_are_excellent                                                                     2.460
## I_am_satisfied_with_my_life                                                                                 2.236
## So_far_I_have_gotten_the_important_things_I_want_in_life                                                    2.206
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                                  3.102
## Attention_deficit_hyperactivity_disorder_ADHD                                                               0.099
## Alcohol_abuse                                                                                               0.042
## Non_alcohol_drug_abuse                                                                                      0.017
## Autism_spectrum_disorder_ASD                                                                                0.028
## Anti_social_personality_disorder                                                                            0.011
## Bipolarity                                                                                                  0.035
## Borderline_Personality_Disorder                                                                             0.015
## Depression                                                                                                  0.222
## General_Anxiety_Disorder_GAD                                                                                0.186
## Obsessive_compulsive_disorder_OCD                                                                           0.035
## Panic_disorder                                                                                              0.045
## Paranoia_Paranoid_personality_disorder                                                                      0.002
## Phobias_social                                                                                              0.014
## Specific_phobias                                                                                            0.015
## Post_traumatic_stress_disorder_PTSD                                                                         0.063
## Schizophrenia                                                                                               0.002
## Schizoid_personality_disorder                                                                               0.002
## Sleeping_disorders                                                                                          0.079
##                                                                                                       mean.ES.ref
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                                     0.283
## Most_of_the_time_I_feel_blue                                                                                0.194
## I_often_feel_as_if_things_were_not_real                                                                     0.142
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                            0.202
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                                   0.231
## I_feel_that_I_have_often_been_punished_without_cause                                                        0.197
## Life_is_a_strain_for_me_much_of_the_time                                                                    0.256
## I_have_strange_and_peculiar_thoughts                                                                        0.253
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                     0.189
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything                   0.198
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to           0.142
## At_times_I_think_I_am_no_good_at_all                                                                        0.255
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                              0.285
## I_am_happy_most_of_the_time                                                                                 0.283
## I_very_seldom_have_spells_of_the_blues                                                                      0.409
## During_the_past_few_years_I_have_been_well_most_of_the_time                                                 0.207
## My_daily_life_is_full_of_things_that_keep_me_interested                                                     0.216
## I_am_usually_calm_and_not_easily_upset                                                                      0.163
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                                    0.166
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                            0.355
## I_am_liked_by_most_people_who_know_me                                                                       0.082
## I_am_not_easily_angered                                                                                     0.212
## I_do_not_mind_meeting_strangers                                                                             0.262
## I_get_all_the_sympathy_I_should                                                                             0.227
## Little_interest_or_pleasure_in_doing_things                                                                 1.027
## Feeling_down_depressed_or_hopeless                                                                          0.978
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                          0.949
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                     0.960
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                                0.457
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                       1.047
## Feeling_panic_or_being_frightened                                                                           0.656
## Avoiding_situations_that_make_you_anxious                                                                   1.100
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                               0.902
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                            0.579
## Thoughts_of_actually_hurting_yourself                                                                       0.294
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                        0.098
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking       0.106
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                               1.158
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home                0.537
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                         0.521
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                              0.428
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories             0.467
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                                 0.581
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                                  0.721
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                           0.395
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                                    0.472
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                            0.375
## Life_satisfaction                                                                                           1.988
## Job_satisfaction                                                                                            2.489
## Social_satisfaction                                                                                         2.357
## Romantic_satisfaction                                                                                       2.379
## Mood_higher_means_better_mood                                                                               2.017
## Anxiety_levels_higher_means_less_anxious                                                                    2.752
## In_most_ways_my_life_is_close_to_my_ideal                                                                   2.534
## The_conditions_of_my_life_are_excellent                                                                     2.460
## I_am_satisfied_with_my_life                                                                                 2.236
## So_far_I_have_gotten_the_important_things_I_want_in_life                                                    2.206
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                                  3.102
## Attention_deficit_hyperactivity_disorder_ADHD                                                               0.099
## Alcohol_abuse                                                                                               0.042
## Non_alcohol_drug_abuse                                                                                      0.017
## Autism_spectrum_disorder_ASD                                                                                0.028
## Anti_social_personality_disorder                                                                            0.011
## Bipolarity                                                                                                  0.035
## Borderline_Personality_Disorder                                                                             0.015
## Depression                                                                                                  0.222
## General_Anxiety_Disorder_GAD                                                                                0.186
## Obsessive_compulsive_disorder_OCD                                                                           0.035
## Panic_disorder                                                                                              0.045
## Paranoia_Paranoid_personality_disorder                                                                      0.002
## Phobias_social                                                                                              0.014
## Specific_phobias                                                                                            0.015
## Post_traumatic_stress_disorder_PTSD                                                                         0.063
## Schizophrenia                                                                                               0.002
## Schizoid_personality_disorder                                                                               0.002
## Sleeping_disorders                                                                                          0.079
#plot item functions
plot(
  dif_irt_mh_all$fits$anchor_liberal, 
  type = "trace", 
  which.items = dif_irt_mh_all$DIF_stats%>% mutate(idx = row_number()) %>% filter(p_adj < 0.05)  %>% pull(idx)
  )

Non-diagnoses
#DIF without diagnoses
dif_irt_mh_symptoms = DIF_test(
  items = mh_vars_num %>% select(all_of(mh_vars_symptoms)),
  model = 1,
  itemtype = mh_vars_options %>% slice(mh_vars_symptoms_idx) %>% pull(itemtype) %>% case_when(. == "graded" ~ "gpcmIRT", .default = .),
  group = d$leftism_median_split,
  verbose = F
)
## There are 8 steps
## Step 1: Initial joint fit
## 
## Step 2: Initial MI fit
## 
## Step 3: Leave one out MI testing
## 
## Step 4: Fit without DIF items, liberal threshold
## 
## Step 5: Fit without DIF items, conservative threshold
## Warning: EM cycles terminated after 500 iterations.
## 
## Step 6: Fit with anchor items, liberal threshold
## Warning: EM cycles terminated after 500 iterations.
## 
## Step 7: Fit with anchor items, conservative threshold
## 
## Step 8: Get scores
#scale level gap and bias
SMD_matrix(d$p_symptoms, d$leftism_median_split)
##       High   Low
## High    NA 0.288
## Low  0.288    NA
dif_irt_mh_symptoms$effect_size_test
## $liberal
##           Effect Size  Value
## 1                STDS 0.3325
## 2                UTDS 4.8077
## 3              UETSDS 0.9227
## 4               ETSSD 0.0112
## 5         Starks.DTFR 0.4181
## 6               UDTFR 4.6408
## 7              UETSDN 0.9750
## 8 theta.of.max.test.D 2.2334
## 9           Test.Dmax 5.9214
## 
## $conservative
##           Effect Size  Value
## 1                STDS 0.3108
## 2                UTDS 1.6062
## 3              UETSDS 0.3140
## 4               ETSSD 0.0104
## 5         Starks.DTFR 0.3382
## 6               UDTFR 1.5464
## 7              UETSDN 0.3409
## 8 theta.of.max.test.D 2.2582
## 9           Test.Dmax 2.2810
#plot scale function
plot(
  dif_irt_mh_symptoms$fits$anchor_liberal,
  type = "score"
)

#what items are biased?
dif_irt_mh_symptoms$effect_size_items
## $liberal
##                                                                                                         SIDS
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               -0.068
## Most_of_the_time_I_feel_blue                                                                           0.000
## I_often_feel_as_if_things_were_not_real                                                                0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                       0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                              0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                   0.000
## Life_is_a_strain_for_me_much_of_the_time                                                               0.000
## I_have_strange_and_peculiar_thoughts                                                                   0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                0.052
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything              0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to      0.049
## At_times_I_think_I_am_no_good_at_all                                                                  -0.057
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                         0.000
## I_am_happy_most_of_the_time                                                                           -0.080
## I_very_seldom_have_spells_of_the_blues                                                                -0.038
## During_the_past_few_years_I_have_been_well_most_of_the_time                                           -0.036
## My_daily_life_is_full_of_things_that_keep_me_interested                                                0.000
## I_am_usually_calm_and_not_easily_upset                                                                 0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                               0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                       0.000
## I_am_liked_by_most_people_who_know_me                                                                  0.048
## I_am_not_easily_angered                                                                                0.000
## I_do_not_mind_meeting_strangers                                                                        0.000
## I_get_all_the_sympathy_I_should                                                                        0.000
## Little_interest_or_pleasure_in_doing_things                                                            0.000
## Feeling_down_depressed_or_hopeless                                                                     0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                     0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                0.201
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                           0.218
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 -0.150
## Feeling_panic_or_being_frightened                                                                      0.064
## Avoiding_situations_that_make_you_anxious                                                              0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                          0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                       0.000
## Thoughts_of_actually_hurting_yourself                                                                  0.113
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                   0.250
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking  0.224
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                          0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home           0.163
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                    0.156
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                         0.174
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories        0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                            0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                             0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                      0.118
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                               0.247
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                      -0.038
## Life_satisfaction                                                                                     -0.173
## Job_satisfaction                                                                                       0.000
## Social_satisfaction                                                                                   -0.183
## Romantic_satisfaction                                                                                 -0.231
## Mood_higher_means_better_mood                                                                         -0.104
## Anxiety_levels_higher_means_less_anxious                                                               0.206
## In_most_ways_my_life_is_close_to_my_ideal                                                             -0.233
## The_conditions_of_my_life_are_excellent                                                               -0.102
## I_am_satisfied_with_my_life                                                                           -0.167
## So_far_I_have_gotten_the_important_things_I_want_in_life                                               0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                            -0.291
##                                                                                                        UIDS
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               0.083
## Most_of_the_time_I_feel_blue                                                                          0.000
## I_often_feel_as_if_things_were_not_real                                                               0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                      0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                             0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                  0.000
## Life_is_a_strain_for_me_much_of_the_time                                                              0.000
## I_have_strange_and_peculiar_thoughts                                                                  0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up               0.052
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything             0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to     0.049
## At_times_I_think_I_am_no_good_at_all                                                                  0.057
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                        0.000
## I_am_happy_most_of_the_time                                                                           0.101
## I_very_seldom_have_spells_of_the_blues                                                                0.111
## During_the_past_few_years_I_have_been_well_most_of_the_time                                           0.067
## My_daily_life_is_full_of_things_that_keep_me_interested                                               0.000
## I_am_usually_calm_and_not_easily_upset                                                                0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                              0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                      0.000
## I_am_liked_by_most_people_who_know_me                                                                 0.048
## I_am_not_easily_angered                                                                               0.000
## I_do_not_mind_meeting_strangers                                                                       0.000
## I_get_all_the_sympathy_I_should                                                                       0.000
## Little_interest_or_pleasure_in_doing_things                                                           0.000
## Feeling_down_depressed_or_hopeless                                                                    0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                    0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                               0.202
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                          0.219
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 0.151
## Feeling_panic_or_being_frightened                                                                     0.118
## Avoiding_situations_that_make_you_anxious                                                             0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                         0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                      0.000
## Thoughts_of_actually_hurting_yourself                                                                 0.113
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                  0.250
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking 0.224
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                         0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home          0.164
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                   0.157
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                        0.175
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories       0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                           0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                            0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                     0.140
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                              0.247
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                      0.069
## Life_satisfaction                                                                                     0.196
## Job_satisfaction                                                                                      0.000
## Social_satisfaction                                                                                   0.199
## Romantic_satisfaction                                                                                 0.231
## Mood_higher_means_better_mood                                                                         0.124
## Anxiety_levels_higher_means_less_anxious                                                              0.267
## In_most_ways_my_life_is_close_to_my_ideal                                                             0.283
## The_conditions_of_my_life_are_excellent                                                               0.171
## I_am_satisfied_with_my_life                                                                           0.247
## So_far_I_have_gotten_the_important_things_I_want_in_life                                              0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                            0.291
##                                                                                                         SIDN
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               -0.067
## Most_of_the_time_I_feel_blue                                                                           0.000
## I_often_feel_as_if_things_were_not_real                                                                0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                       0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                              0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                   0.000
## Life_is_a_strain_for_me_much_of_the_time                                                               0.000
## I_have_strange_and_peculiar_thoughts                                                                   0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                0.045
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything              0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to      0.045
## At_times_I_think_I_am_no_good_at_all                                                                  -0.052
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                         0.000
## I_am_happy_most_of_the_time                                                                           -0.067
## I_very_seldom_have_spells_of_the_blues                                                                -0.025
## During_the_past_few_years_I_have_been_well_most_of_the_time                                           -0.032
## My_daily_life_is_full_of_things_that_keep_me_interested                                                0.000
## I_am_usually_calm_and_not_easily_upset                                                                 0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                               0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                       0.000
## I_am_liked_by_most_people_who_know_me                                                                  0.046
## I_am_not_easily_angered                                                                                0.000
## I_do_not_mind_meeting_strangers                                                                        0.000
## I_get_all_the_sympathy_I_should                                                                        0.000
## Little_interest_or_pleasure_in_doing_things                                                            0.000
## Feeling_down_depressed_or_hopeless                                                                     0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                     0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                0.194
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                           0.211
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 -0.152
## Feeling_panic_or_being_frightened                                                                      0.050
## Avoiding_situations_that_make_you_anxious                                                              0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                          0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                       0.000
## Thoughts_of_actually_hurting_yourself                                                                  0.106
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                   0.260
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking  0.232
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                          0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home           0.156
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                    0.144
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                         0.158
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories        0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                            0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                             0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                      0.121
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                               0.246
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                      -0.033
## Life_satisfaction                                                                                     -0.155
## Job_satisfaction                                                                                       0.000
## Social_satisfaction                                                                                   -0.174
## Romantic_satisfaction                                                                                 -0.224
## Mood_higher_means_better_mood                                                                         -0.101
## Anxiety_levels_higher_means_less_anxious                                                               0.217
## In_most_ways_my_life_is_close_to_my_ideal                                                             -0.214
## The_conditions_of_my_life_are_excellent                                                               -0.089
## I_am_satisfied_with_my_life                                                                           -0.142
## So_far_I_have_gotten_the_important_things_I_want_in_life                                               0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                            -0.286
##                                                                                                        UIDN
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               0.083
## Most_of_the_time_I_feel_blue                                                                          0.000
## I_often_feel_as_if_things_were_not_real                                                               0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                      0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                             0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                  0.000
## Life_is_a_strain_for_me_much_of_the_time                                                              0.000
## I_have_strange_and_peculiar_thoughts                                                                  0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up               0.045
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything             0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to     0.045
## At_times_I_think_I_am_no_good_at_all                                                                  0.052
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                        0.000
## I_am_happy_most_of_the_time                                                                           0.091
## I_very_seldom_have_spells_of_the_blues                                                                0.108
## During_the_past_few_years_I_have_been_well_most_of_the_time                                           0.066
## My_daily_life_is_full_of_things_that_keep_me_interested                                               0.000
## I_am_usually_calm_and_not_easily_upset                                                                0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                              0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                      0.000
## I_am_liked_by_most_people_who_know_me                                                                 0.046
## I_am_not_easily_angered                                                                               0.000
## I_do_not_mind_meeting_strangers                                                                       0.000
## I_get_all_the_sympathy_I_should                                                                       0.000
## Little_interest_or_pleasure_in_doing_things                                                           0.000
## Feeling_down_depressed_or_hopeless                                                                    0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                    0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                               0.194
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                          0.211
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 0.154
## Feeling_panic_or_being_frightened                                                                     0.109
## Avoiding_situations_that_make_you_anxious                                                             0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                         0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                      0.000
## Thoughts_of_actually_hurting_yourself                                                                 0.106
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                  0.260
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking 0.232
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                         0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home          0.158
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                   0.145
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                        0.160
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories       0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                           0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                            0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                     0.144
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                              0.246
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                      0.079
## Life_satisfaction                                                                                     0.175
## Job_satisfaction                                                                                      0.000
## Social_satisfaction                                                                                   0.187
## Romantic_satisfaction                                                                                 0.224
## Mood_higher_means_better_mood                                                                         0.116
## Anxiety_levels_higher_means_less_anxious                                                              0.284
## In_most_ways_my_life_is_close_to_my_ideal                                                             0.256
## The_conditions_of_my_life_are_excellent                                                               0.156
## I_am_satisfied_with_my_life                                                                           0.224
## So_far_I_have_gotten_the_important_things_I_want_in_life                                              0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                            0.286
##                                                                                                         ESSD
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               -0.248
## Most_of_the_time_I_feel_blue                                                                           0.000
## I_often_feel_as_if_things_were_not_real                                                                0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                       0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                              0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                   0.000
## Life_is_a_strain_for_me_much_of_the_time                                                               0.000
## I_have_strange_and_peculiar_thoughts                                                                   0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                0.209
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything              0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to      0.273
## At_times_I_think_I_am_no_good_at_all                                                                  -0.208
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                         0.000
## I_am_happy_most_of_the_time                                                                           -0.303
## I_very_seldom_have_spells_of_the_blues                                                                -0.147
## During_the_past_few_years_I_have_been_well_most_of_the_time                                           -0.186
## My_daily_life_is_full_of_things_that_keep_me_interested                                                0.000
## I_am_usually_calm_and_not_easily_upset                                                                 0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                               0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                       0.000
## I_am_liked_by_most_people_who_know_me                                                                  0.479
## I_am_not_easily_angered                                                                                0.000
## I_do_not_mind_meeting_strangers                                                                        0.000
## I_get_all_the_sympathy_I_should                                                                        0.000
## Little_interest_or_pleasure_in_doing_things                                                            0.000
## Feeling_down_depressed_or_hopeless                                                                     0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                     0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                0.408
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                           0.554
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 -0.174
## Feeling_panic_or_being_frightened                                                                      0.080
## Avoiding_situations_that_make_you_anxious                                                              0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                          0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                       0.000
## Thoughts_of_actually_hurting_yourself                                                                  0.222
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                   0.785
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking  0.745
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                          0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home           0.279
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                    0.240
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                         0.341
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories        0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                            0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                             0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                      0.561
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                               0.976
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                      -0.130
## Life_satisfaction                                                                                     -0.160
## Job_satisfaction                                                                                       0.000
## Social_satisfaction                                                                                   -0.174
## Romantic_satisfaction                                                                                 -0.234
## Mood_higher_means_better_mood                                                                         -0.097
## Anxiety_levels_higher_means_less_anxious                                                               0.304
## In_most_ways_my_life_is_close_to_my_ideal                                                             -0.202
## The_conditions_of_my_life_are_excellent                                                               -0.093
## I_am_satisfied_with_my_life                                                                           -0.137
## So_far_I_have_gotten_the_important_things_I_want_in_life                                               0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                            -0.289
##                                                                                                       theta.of.max.D
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                                        0.090
## Most_of_the_time_I_feel_blue                                                                                  -1.505
## I_often_feel_as_if_things_were_not_real                                                                       -1.505
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                              -1.505
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                                     -1.505
## I_feel_that_I_have_often_been_punished_without_cause                                                          -1.505
## Life_is_a_strain_for_me_much_of_the_time                                                                      -1.505
## I_have_strange_and_peculiar_thoughts                                                                          -1.505
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                        0.896
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything                     -1.505
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to              1.217
## At_times_I_think_I_am_no_good_at_all                                                                           0.433
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                                -1.505
## I_am_happy_most_of_the_time                                                                                    0.939
## I_very_seldom_have_spells_of_the_blues                                                                         0.949
## During_the_past_few_years_I_have_been_well_most_of_the_time                                                    1.523
## My_daily_life_is_full_of_things_that_keep_me_interested                                                       -1.505
## I_am_usually_calm_and_not_easily_upset                                                                        -1.505
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                                      -1.505
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                              -1.505
## I_am_liked_by_most_people_who_know_me                                                                          1.703
## I_am_not_easily_angered                                                                                       -1.505
## I_do_not_mind_meeting_strangers                                                                               -1.505
## I_get_all_the_sympathy_I_should                                                                               -1.505
## Little_interest_or_pleasure_in_doing_things                                                                   -1.505
## Feeling_down_depressed_or_hopeless                                                                            -1.505
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                            -1.505
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                        1.407
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                                   1.740
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                         -0.474
## Feeling_panic_or_being_frightened                                                                              1.065
## Avoiding_situations_that_make_you_anxious                                                                     -1.505
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                                 -1.505
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                              -1.505
## Thoughts_of_actually_hurting_yourself                                                                          1.331
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                           2.233
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking          2.233
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                                 -1.505
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home                   1.647
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                            1.217
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                                 1.065
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories               -1.505
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                                   -1.505
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                                    -1.505
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                              2.233
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                                       2.233
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                               2.233
## Life_satisfaction                                                                                              0.727
## Job_satisfaction                                                                                              -1.505
## Social_satisfaction                                                                                            0.664
## Romantic_satisfaction                                                                                          0.379
## Mood_higher_means_better_mood                                                                                  1.823
## Anxiety_levels_higher_means_less_anxious                                                                      -2.675
## In_most_ways_my_life_is_close_to_my_ideal                                                                      0.939
## The_conditions_of_my_life_are_excellent                                                                        0.680
## I_am_satisfied_with_my_life                                                                                    0.902
## So_far_I_have_gotten_the_important_things_I_want_in_life                                                      -1.505
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                                     0.165
##                                                                                                        max.D
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               -0.170
## Most_of_the_time_I_feel_blue                                                                           0.000
## I_often_feel_as_if_things_were_not_real                                                                0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                       0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                              0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                   0.000
## Life_is_a_strain_for_me_much_of_the_time                                                               0.000
## I_have_strange_and_peculiar_thoughts                                                                   0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                0.169
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything              0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to      0.170
## At_times_I_think_I_am_no_good_at_all                                                                  -0.116
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                         0.000
## I_am_happy_most_of_the_time                                                                           -0.322
## I_very_seldom_have_spells_of_the_blues                                                                -0.225
## During_the_past_few_years_I_have_been_well_most_of_the_time                                           -0.270
## My_daily_life_is_full_of_things_that_keep_me_interested                                                0.000
## I_am_usually_calm_and_not_easily_upset                                                                 0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                               0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                       0.000
## I_am_liked_by_most_people_who_know_me                                                                  0.155
## I_am_not_easily_angered                                                                                0.000
## I_do_not_mind_meeting_strangers                                                                        0.000
## I_get_all_the_sympathy_I_should                                                                        0.000
## Little_interest_or_pleasure_in_doing_things                                                            0.000
## Feeling_down_depressed_or_hopeless                                                                     0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                     0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                0.402
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                           0.647
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 -0.229
## Feeling_panic_or_being_frightened                                                                      0.455
## Avoiding_situations_that_make_you_anxious                                                              0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                          0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                       0.000
## Thoughts_of_actually_hurting_yourself                                                                  0.661
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                   1.853
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking  1.666
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                          0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home           0.683
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                    0.617
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                         0.497
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories        0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                            0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                             0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                      1.066
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                               0.665
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                       0.509
## Life_satisfaction                                                                                     -0.415
## Job_satisfaction                                                                                       0.000
## Social_satisfaction                                                                                   -0.315
## Romantic_satisfaction                                                                                 -0.327
## Mood_higher_means_better_mood                                                                         -0.229
## Anxiety_levels_higher_means_less_anxious                                                               0.616
## In_most_ways_my_life_is_close_to_my_ideal                                                             -0.636
## The_conditions_of_my_life_are_excellent                                                               -0.289
## I_am_satisfied_with_my_life                                                                           -0.634
## So_far_I_have_gotten_the_important_things_I_want_in_life                                               0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                            -0.366
##                                                                                                       mean.ES.foc
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                                     0.218
## Most_of_the_time_I_feel_blue                                                                                0.194
## I_often_feel_as_if_things_were_not_real                                                                     0.141
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                            0.203
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                                   0.232
## I_feel_that_I_have_often_been_punished_without_cause                                                        0.197
## Life_is_a_strain_for_me_much_of_the_time                                                                    0.257
## I_have_strange_and_peculiar_thoughts                                                                        0.254
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                     0.218
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything                   0.198
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to           0.169
## At_times_I_think_I_am_no_good_at_all                                                                        0.226
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                              0.286
## I_am_happy_most_of_the_time                                                                                 0.204
## I_very_seldom_have_spells_of_the_blues                                                                      0.373
## During_the_past_few_years_I_have_been_well_most_of_the_time                                                 0.185
## My_daily_life_is_full_of_things_that_keep_me_interested                                                     0.216
## I_am_usually_calm_and_not_easily_upset                                                                      0.163
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                                    0.165
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                            0.355
## I_am_liked_by_most_people_who_know_me                                                                       0.107
## I_am_not_easily_angered                                                                                     0.212
## I_do_not_mind_meeting_strangers                                                                             0.263
## I_get_all_the_sympathy_I_should                                                                             0.227
## Little_interest_or_pleasure_in_doing_things                                                                 1.038
## Feeling_down_depressed_or_hopeless                                                                          0.972
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                          0.934
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                     1.048
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                                0.674
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                       0.963
## Feeling_panic_or_being_frightened                                                                           0.684
## Avoiding_situations_that_make_you_anxious                                                                   1.118
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                               0.894
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                            0.567
## Thoughts_of_actually_hurting_yourself                                                                       0.349
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                        0.343
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking       0.327
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                               1.157
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home                0.622
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                         0.603
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                              0.513
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories             0.459
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                                 0.563
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                                  0.724
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                           0.461
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                                    0.723
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                            0.356
## Life_satisfaction                                                                                           1.873
## Job_satisfaction                                                                                            2.490
## Social_satisfaction                                                                                         2.221
## Romantic_satisfaction                                                                                       2.221
## Mood_higher_means_better_mood                                                                               1.895
## Anxiety_levels_higher_means_less_anxious                                                                    2.923
## In_most_ways_my_life_is_close_to_my_ideal                                                                   2.376
## The_conditions_of_my_life_are_excellent                                                                     2.359
## I_am_satisfied_with_my_life                                                                                 2.107
## So_far_I_have_gotten_the_important_things_I_want_in_life                                                    2.179
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                                  2.949
##                                                                                                       mean.ES.ref
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                                     0.286
## Most_of_the_time_I_feel_blue                                                                                0.194
## I_often_feel_as_if_things_were_not_real                                                                     0.141
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                            0.203
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                                   0.232
## I_feel_that_I_have_often_been_punished_without_cause                                                        0.197
## Life_is_a_strain_for_me_much_of_the_time                                                                    0.257
## I_have_strange_and_peculiar_thoughts                                                                        0.254
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                     0.166
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything                   0.198
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to           0.121
## At_times_I_think_I_am_no_good_at_all                                                                        0.283
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                              0.286
## I_am_happy_most_of_the_time                                                                                 0.285
## I_very_seldom_have_spells_of_the_blues                                                                      0.411
## During_the_past_few_years_I_have_been_well_most_of_the_time                                                 0.220
## My_daily_life_is_full_of_things_that_keep_me_interested                                                     0.216
## I_am_usually_calm_and_not_easily_upset                                                                      0.163
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                                    0.165
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                            0.355
## I_am_liked_by_most_people_who_know_me                                                                       0.059
## I_am_not_easily_angered                                                                                     0.212
## I_do_not_mind_meeting_strangers                                                                             0.263
## I_get_all_the_sympathy_I_should                                                                             0.227
## Little_interest_or_pleasure_in_doing_things                                                                 1.038
## Feeling_down_depressed_or_hopeless                                                                          0.972
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                          0.934
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                     0.847
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                                0.456
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                       1.113
## Feeling_panic_or_being_frightened                                                                           0.620
## Avoiding_situations_that_make_you_anxious                                                                   1.118
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                               0.894
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                            0.567
## Thoughts_of_actually_hurting_yourself                                                                       0.236
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                        0.092
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking       0.103
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                               1.157
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home                0.459
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                         0.447
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                              0.339
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories             0.459
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                                 0.563
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                                  0.724
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                           0.343
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                                    0.476
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                            0.395
## Life_satisfaction                                                                                           2.045
## Job_satisfaction                                                                                            2.490
## Social_satisfaction                                                                                         2.404
## Romantic_satisfaction                                                                                       2.452
## Mood_higher_means_better_mood                                                                               1.998
## Anxiety_levels_higher_means_less_anxious                                                                    2.717
## In_most_ways_my_life_is_close_to_my_ideal                                                                   2.609
## The_conditions_of_my_life_are_excellent                                                                     2.461
## I_am_satisfied_with_my_life                                                                                 2.274
## So_far_I_have_gotten_the_important_things_I_want_in_life                                                    2.179
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                                  3.240
## 
## $conservative
##                                                                                                         SIDS
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               -0.066
## Most_of_the_time_I_feel_blue                                                                           0.000
## I_often_feel_as_if_things_were_not_real                                                                0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                       0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                              0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                   0.000
## Life_is_a_strain_for_me_much_of_the_time                                                               0.000
## I_have_strange_and_peculiar_thoughts                                                                   0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                0.000
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything              0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to      0.000
## At_times_I_think_I_am_no_good_at_all                                                                   0.000
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                         0.000
## I_am_happy_most_of_the_time                                                                           -0.079
## I_very_seldom_have_spells_of_the_blues                                                                -0.035
## During_the_past_few_years_I_have_been_well_most_of_the_time                                           -0.035
## My_daily_life_is_full_of_things_that_keep_me_interested                                                0.000
## I_am_usually_calm_and_not_easily_upset                                                                 0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                               0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                       0.000
## I_am_liked_by_most_people_who_know_me                                                                  0.000
## I_am_not_easily_angered                                                                                0.000
## I_do_not_mind_meeting_strangers                                                                        0.000
## I_get_all_the_sympathy_I_should                                                                        0.000
## Little_interest_or_pleasure_in_doing_things                                                            0.000
## Feeling_down_depressed_or_hopeless                                                                     0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                     0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                0.000
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                           0.219
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                  0.000
## Feeling_panic_or_being_frightened                                                                      0.000
## Avoiding_situations_that_make_you_anxious                                                              0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                          0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                       0.000
## Thoughts_of_actually_hurting_yourself                                                                  0.000
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                   0.249
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking  0.222
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                          0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home           0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                    0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                         0.170
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories        0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                            0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                             0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                      0.000
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                               0.000
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                       0.000
## Life_satisfaction                                                                                      0.000
## Job_satisfaction                                                                                       0.000
## Social_satisfaction                                                                                    0.000
## Romantic_satisfaction                                                                                  0.000
## Mood_higher_means_better_mood                                                                         -0.104
## Anxiety_levels_higher_means_less_anxious                                                               0.000
## In_most_ways_my_life_is_close_to_my_ideal                                                             -0.230
## The_conditions_of_my_life_are_excellent                                                                0.000
## I_am_satisfied_with_my_life                                                                            0.000
## So_far_I_have_gotten_the_important_things_I_want_in_life                                               0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                             0.000
##                                                                                                        UIDS
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               0.077
## Most_of_the_time_I_feel_blue                                                                          0.000
## I_often_feel_as_if_things_were_not_real                                                               0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                      0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                             0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                  0.000
## Life_is_a_strain_for_me_much_of_the_time                                                              0.000
## I_have_strange_and_peculiar_thoughts                                                                  0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up               0.000
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything             0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to     0.000
## At_times_I_think_I_am_no_good_at_all                                                                  0.000
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                        0.000
## I_am_happy_most_of_the_time                                                                           0.100
## I_very_seldom_have_spells_of_the_blues                                                                0.113
## During_the_past_few_years_I_have_been_well_most_of_the_time                                           0.070
## My_daily_life_is_full_of_things_that_keep_me_interested                                               0.000
## I_am_usually_calm_and_not_easily_upset                                                                0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                              0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                      0.000
## I_am_liked_by_most_people_who_know_me                                                                 0.000
## I_am_not_easily_angered                                                                               0.000
## I_do_not_mind_meeting_strangers                                                                       0.000
## I_get_all_the_sympathy_I_should                                                                       0.000
## Little_interest_or_pleasure_in_doing_things                                                           0.000
## Feeling_down_depressed_or_hopeless                                                                    0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                    0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                               0.000
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                          0.219
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 0.000
## Feeling_panic_or_being_frightened                                                                     0.000
## Avoiding_situations_that_make_you_anxious                                                             0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                         0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                      0.000
## Thoughts_of_actually_hurting_yourself                                                                 0.000
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                  0.249
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking 0.222
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                         0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home          0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                   0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                        0.173
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories       0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                           0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                            0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                     0.000
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                              0.000
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                      0.000
## Life_satisfaction                                                                                     0.000
## Job_satisfaction                                                                                      0.000
## Social_satisfaction                                                                                   0.000
## Romantic_satisfaction                                                                                 0.000
## Mood_higher_means_better_mood                                                                         0.119
## Anxiety_levels_higher_means_less_anxious                                                              0.000
## In_most_ways_my_life_is_close_to_my_ideal                                                             0.265
## The_conditions_of_my_life_are_excellent                                                               0.000
## I_am_satisfied_with_my_life                                                                           0.000
## So_far_I_have_gotten_the_important_things_I_want_in_life                                              0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                            0.000
##                                                                                                         SIDN
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               -0.065
## Most_of_the_time_I_feel_blue                                                                           0.000
## I_often_feel_as_if_things_were_not_real                                                                0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                       0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                              0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                   0.000
## Life_is_a_strain_for_me_much_of_the_time                                                               0.000
## I_have_strange_and_peculiar_thoughts                                                                   0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                0.000
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything              0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to      0.000
## At_times_I_think_I_am_no_good_at_all                                                                   0.000
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                         0.000
## I_am_happy_most_of_the_time                                                                           -0.067
## I_very_seldom_have_spells_of_the_blues                                                                -0.022
## During_the_past_few_years_I_have_been_well_most_of_the_time                                           -0.031
## My_daily_life_is_full_of_things_that_keep_me_interested                                                0.000
## I_am_usually_calm_and_not_easily_upset                                                                 0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                               0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                       0.000
## I_am_liked_by_most_people_who_know_me                                                                  0.000
## I_am_not_easily_angered                                                                                0.000
## I_do_not_mind_meeting_strangers                                                                        0.000
## I_get_all_the_sympathy_I_should                                                                        0.000
## Little_interest_or_pleasure_in_doing_things                                                            0.000
## Feeling_down_depressed_or_hopeless                                                                     0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                     0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                0.000
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                           0.212
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                  0.000
## Feeling_panic_or_being_frightened                                                                      0.000
## Avoiding_situations_that_make_you_anxious                                                              0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                          0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                       0.000
## Thoughts_of_actually_hurting_yourself                                                                  0.000
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                   0.251
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking  0.224
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                          0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home           0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                    0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                         0.154
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories        0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                            0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                             0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                      0.000
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                               0.000
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                       0.000
## Life_satisfaction                                                                                      0.000
## Job_satisfaction                                                                                       0.000
## Social_satisfaction                                                                                    0.000
## Romantic_satisfaction                                                                                  0.000
## Mood_higher_means_better_mood                                                                         -0.102
## Anxiety_levels_higher_means_less_anxious                                                               0.000
## In_most_ways_my_life_is_close_to_my_ideal                                                             -0.215
## The_conditions_of_my_life_are_excellent                                                                0.000
## I_am_satisfied_with_my_life                                                                            0.000
## So_far_I_have_gotten_the_important_things_I_want_in_life                                               0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                             0.000
##                                                                                                        UIDN
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               0.078
## Most_of_the_time_I_feel_blue                                                                          0.000
## I_often_feel_as_if_things_were_not_real                                                               0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                      0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                             0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                  0.000
## Life_is_a_strain_for_me_much_of_the_time                                                              0.000
## I_have_strange_and_peculiar_thoughts                                                                  0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up               0.000
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything             0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to     0.000
## At_times_I_think_I_am_no_good_at_all                                                                  0.000
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                        0.000
## I_am_happy_most_of_the_time                                                                           0.090
## I_very_seldom_have_spells_of_the_blues                                                                0.110
## During_the_past_few_years_I_have_been_well_most_of_the_time                                           0.069
## My_daily_life_is_full_of_things_that_keep_me_interested                                               0.000
## I_am_usually_calm_and_not_easily_upset                                                                0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                              0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                      0.000
## I_am_liked_by_most_people_who_know_me                                                                 0.000
## I_am_not_easily_angered                                                                               0.000
## I_do_not_mind_meeting_strangers                                                                       0.000
## I_get_all_the_sympathy_I_should                                                                       0.000
## Little_interest_or_pleasure_in_doing_things                                                           0.000
## Feeling_down_depressed_or_hopeless                                                                    0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                    0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                               0.000
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                          0.212
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 0.000
## Feeling_panic_or_being_frightened                                                                     0.000
## Avoiding_situations_that_make_you_anxious                                                             0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                         0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                      0.000
## Thoughts_of_actually_hurting_yourself                                                                 0.000
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                  0.251
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking 0.224
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                         0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home          0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                   0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                        0.159
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories       0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                           0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                            0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                     0.000
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                              0.000
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                      0.000
## Life_satisfaction                                                                                     0.000
## Job_satisfaction                                                                                      0.000
## Social_satisfaction                                                                                   0.000
## Romantic_satisfaction                                                                                 0.000
## Mood_higher_means_better_mood                                                                         0.112
## Anxiety_levels_higher_means_less_anxious                                                              0.000
## In_most_ways_my_life_is_close_to_my_ideal                                                             0.242
## The_conditions_of_my_life_are_excellent                                                               0.000
## I_am_satisfied_with_my_life                                                                           0.000
## So_far_I_have_gotten_the_important_things_I_want_in_life                                              0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                            0.000
##                                                                                                         ESSD
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               -0.239
## Most_of_the_time_I_feel_blue                                                                           0.000
## I_often_feel_as_if_things_were_not_real                                                                0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                       0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                              0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                   0.000
## Life_is_a_strain_for_me_much_of_the_time                                                               0.000
## I_have_strange_and_peculiar_thoughts                                                                   0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                0.000
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything              0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to      0.000
## At_times_I_think_I_am_no_good_at_all                                                                   0.000
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                         0.000
## I_am_happy_most_of_the_time                                                                           -0.297
## I_very_seldom_have_spells_of_the_blues                                                                -0.132
## During_the_past_few_years_I_have_been_well_most_of_the_time                                           -0.182
## My_daily_life_is_full_of_things_that_keep_me_interested                                                0.000
## I_am_usually_calm_and_not_easily_upset                                                                 0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                               0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                       0.000
## I_am_liked_by_most_people_who_know_me                                                                  0.000
## I_am_not_easily_angered                                                                                0.000
## I_do_not_mind_meeting_strangers                                                                        0.000
## I_get_all_the_sympathy_I_should                                                                        0.000
## Little_interest_or_pleasure_in_doing_things                                                            0.000
## Feeling_down_depressed_or_hopeless                                                                     0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                     0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                0.000
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                           0.559
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                  0.000
## Feeling_panic_or_being_frightened                                                                      0.000
## Avoiding_situations_that_make_you_anxious                                                              0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                          0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                       0.000
## Thoughts_of_actually_hurting_yourself                                                                  0.000
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                   0.800
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking  0.760
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                          0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home           0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                    0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                         0.327
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories        0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                            0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                             0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                      0.000
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                               0.000
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                       0.000
## Life_satisfaction                                                                                      0.000
## Job_satisfaction                                                                                       0.000
## Social_satisfaction                                                                                    0.000
## Romantic_satisfaction                                                                                  0.000
## Mood_higher_means_better_mood                                                                         -0.095
## Anxiety_levels_higher_means_less_anxious                                                               0.000
## In_most_ways_my_life_is_close_to_my_ideal                                                             -0.196
## The_conditions_of_my_life_are_excellent                                                                0.000
## I_am_satisfied_with_my_life                                                                            0.000
## So_far_I_have_gotten_the_important_things_I_want_in_life                                               0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                             0.000
##                                                                                                       theta.of.max.D
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                                        0.102
## Most_of_the_time_I_feel_blue                                                                                  -1.447
## I_often_feel_as_if_things_were_not_real                                                                       -1.447
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                              -1.447
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                                     -1.447
## I_feel_that_I_have_often_been_punished_without_cause                                                          -1.447
## Life_is_a_strain_for_me_much_of_the_time                                                                      -1.447
## I_have_strange_and_peculiar_thoughts                                                                          -1.447
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                       -1.447
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything                     -1.447
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to             -1.447
## At_times_I_think_I_am_no_good_at_all                                                                          -1.447
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                                -1.447
## I_am_happy_most_of_the_time                                                                                    0.941
## I_very_seldom_have_spells_of_the_blues                                                                         0.962
## During_the_past_few_years_I_have_been_well_most_of_the_time                                                    1.536
## My_daily_life_is_full_of_things_that_keep_me_interested                                                       -1.447
## I_am_usually_calm_and_not_easily_upset                                                                        -1.447
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                                      -1.447
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                              -1.447
## I_am_liked_by_most_people_who_know_me                                                                         -1.447
## I_am_not_easily_angered                                                                                       -1.447
## I_do_not_mind_meeting_strangers                                                                               -1.447
## I_get_all_the_sympathy_I_should                                                                               -1.447
## Little_interest_or_pleasure_in_doing_things                                                                   -1.447
## Feeling_down_depressed_or_hopeless                                                                            -1.447
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                            -1.447
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                       -1.447
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                                   1.536
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                         -1.447
## Feeling_panic_or_being_frightened                                                                             -1.447
## Avoiding_situations_that_make_you_anxious                                                                     -1.447
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                                 -1.447
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                              -1.447
## Thoughts_of_actually_hurting_yourself                                                                         -1.447
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                           2.258
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking          2.130
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                                 -1.447
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home                  -1.447
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                           -1.447
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                                 0.941
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories               -1.447
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                                   -1.447
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                                    -1.447
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                             -1.447
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                                      -1.447
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                              -1.447
## Life_satisfaction                                                                                             -1.447
## Job_satisfaction                                                                                              -1.447
## Social_satisfaction                                                                                           -1.447
## Romantic_satisfaction                                                                                         -1.447
## Mood_higher_means_better_mood                                                                                  0.384
## Anxiety_levels_higher_means_less_anxious                                                                      -1.447
## In_most_ways_my_life_is_close_to_my_ideal                                                                      0.883
## The_conditions_of_my_life_are_excellent                                                                       -1.447
## I_am_satisfied_with_my_life                                                                                   -1.447
## So_far_I_have_gotten_the_important_things_I_want_in_life                                                      -1.447
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                                    -1.447
##                                                                                                        max.D
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               -0.161
## Most_of_the_time_I_feel_blue                                                                           0.000
## I_often_feel_as_if_things_were_not_real                                                                0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                       0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                              0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                   0.000
## Life_is_a_strain_for_me_much_of_the_time                                                               0.000
## I_have_strange_and_peculiar_thoughts                                                                   0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                0.000
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything              0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to      0.000
## At_times_I_think_I_am_no_good_at_all                                                                   0.000
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                         0.000
## I_am_happy_most_of_the_time                                                                           -0.318
## I_very_seldom_have_spells_of_the_blues                                                                -0.227
## During_the_past_few_years_I_have_been_well_most_of_the_time                                           -0.280
## My_daily_life_is_full_of_things_that_keep_me_interested                                                0.000
## I_am_usually_calm_and_not_easily_upset                                                                 0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                               0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                       0.000
## I_am_liked_by_most_people_who_know_me                                                                  0.000
## I_am_not_easily_angered                                                                                0.000
## I_do_not_mind_meeting_strangers                                                                        0.000
## I_get_all_the_sympathy_I_should                                                                        0.000
## Little_interest_or_pleasure_in_doing_things                                                            0.000
## Feeling_down_depressed_or_hopeless                                                                     0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                     0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                0.000
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                           0.511
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                  0.000
## Feeling_panic_or_being_frightened                                                                      0.000
## Avoiding_situations_that_make_you_anxious                                                              0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                          0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                       0.000
## Thoughts_of_actually_hurting_yourself                                                                  0.000
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                   1.562
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking  1.404
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                          0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home           0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                    0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                         0.413
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories        0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                            0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                             0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                      0.000
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                               0.000
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                       0.000
## Life_satisfaction                                                                                      0.000
## Job_satisfaction                                                                                       0.000
## Social_satisfaction                                                                                    0.000
## Romantic_satisfaction                                                                                  0.000
## Mood_higher_means_better_mood                                                                         -0.204
## Anxiety_levels_higher_means_less_anxious                                                               0.000
## In_most_ways_my_life_is_close_to_my_ideal                                                             -0.565
## The_conditions_of_my_life_are_excellent                                                                0.000
## I_am_satisfied_with_my_life                                                                            0.000
## So_far_I_have_gotten_the_important_things_I_want_in_life                                               0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                             0.000
##                                                                                                       mean.ES.foc
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                                     0.218
## Most_of_the_time_I_feel_blue                                                                                0.195
## I_often_feel_as_if_things_were_not_real                                                                     0.142
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                            0.203
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                                   0.232
## I_feel_that_I_have_often_been_punished_without_cause                                                        0.197
## Life_is_a_strain_for_me_much_of_the_time                                                                    0.256
## I_have_strange_and_peculiar_thoughts                                                                        0.254
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                     0.190
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything                   0.199
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to           0.143
## At_times_I_think_I_am_no_good_at_all                                                                        0.255
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                              0.285
## I_am_happy_most_of_the_time                                                                                 0.204
## I_very_seldom_have_spells_of_the_blues                                                                      0.373
## During_the_past_few_years_I_have_been_well_most_of_the_time                                                 0.185
## My_daily_life_is_full_of_things_that_keep_me_interested                                                     0.216
## I_am_usually_calm_and_not_easily_upset                                                                      0.164
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                                    0.166
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                            0.355
## I_am_liked_by_most_people_who_know_me                                                                       0.082
## I_am_not_easily_angered                                                                                     0.212
## I_do_not_mind_meeting_strangers                                                                             0.262
## I_get_all_the_sympathy_I_should                                                                             0.227
## Little_interest_or_pleasure_in_doing_things                                                                 1.037
## Feeling_down_depressed_or_hopeless                                                                          0.972
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                          0.934
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                     0.942
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                                0.674
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                       1.035
## Feeling_panic_or_being_frightened                                                                           0.646
## Avoiding_situations_that_make_you_anxious                                                                   1.118
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                               0.895
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                            0.571
## Thoughts_of_actually_hurting_yourself                                                                       0.289
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                        0.343
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking       0.327
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                               1.157
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home                0.533
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                         0.519
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                              0.513
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories             0.464
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                                 0.567
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                                  0.727
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                           0.392
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                                    0.594
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                            0.373
## Life_satisfaction                                                                                           1.967
## Job_satisfaction                                                                                            2.487
## Social_satisfaction                                                                                         2.316
## Romantic_satisfaction                                                                                       2.335
## Mood_higher_means_better_mood                                                                               1.895
## Anxiety_levels_higher_means_less_anxious                                                                    2.839
## In_most_ways_my_life_is_close_to_my_ideal                                                                   2.376
## The_conditions_of_my_life_are_excellent                                                                     2.417
## I_am_satisfied_with_my_life                                                                                 2.205
## So_far_I_have_gotten_the_important_things_I_want_in_life                                                    2.178
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                                  3.090
##                                                                                                       mean.ES.ref
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                                     0.284
## Most_of_the_time_I_feel_blue                                                                                0.195
## I_often_feel_as_if_things_were_not_real                                                                     0.142
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                            0.203
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                                   0.232
## I_feel_that_I_have_often_been_punished_without_cause                                                        0.197
## Life_is_a_strain_for_me_much_of_the_time                                                                    0.256
## I_have_strange_and_peculiar_thoughts                                                                        0.254
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                     0.190
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything                   0.199
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to           0.143
## At_times_I_think_I_am_no_good_at_all                                                                        0.255
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                              0.285
## I_am_happy_most_of_the_time                                                                                 0.283
## I_very_seldom_have_spells_of_the_blues                                                                      0.407
## During_the_past_few_years_I_have_been_well_most_of_the_time                                                 0.220
## My_daily_life_is_full_of_things_that_keep_me_interested                                                     0.216
## I_am_usually_calm_and_not_easily_upset                                                                      0.164
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                                    0.166
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                            0.355
## I_am_liked_by_most_people_who_know_me                                                                       0.082
## I_am_not_easily_angered                                                                                     0.212
## I_do_not_mind_meeting_strangers                                                                             0.262
## I_get_all_the_sympathy_I_should                                                                             0.227
## Little_interest_or_pleasure_in_doing_things                                                                 1.037
## Feeling_down_depressed_or_hopeless                                                                          0.972
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                          0.934
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                     0.942
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                                0.455
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                       1.035
## Feeling_panic_or_being_frightened                                                                           0.646
## Avoiding_situations_that_make_you_anxious                                                                   1.118
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                               0.895
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                            0.571
## Thoughts_of_actually_hurting_yourself                                                                       0.289
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                        0.094
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking       0.105
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                               1.157
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home                0.533
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                         0.519
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                              0.344
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories             0.464
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                                 0.567
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                                  0.727
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                           0.392
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                                    0.594
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                            0.373
## Life_satisfaction                                                                                           1.967
## Job_satisfaction                                                                                            2.487
## Social_satisfaction                                                                                         2.316
## Romantic_satisfaction                                                                                       2.335
## Mood_higher_means_better_mood                                                                               1.999
## Anxiety_levels_higher_means_less_anxious                                                                    2.839
## In_most_ways_my_life_is_close_to_my_ideal                                                                   2.605
## The_conditions_of_my_life_are_excellent                                                                     2.417
## I_am_satisfied_with_my_life                                                                                 2.205
## So_far_I_have_gotten_the_important_things_I_want_in_life                                                    2.178
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                                  3.090
#plot item functions
plot(
  dif_irt_mh_symptoms$fits$anchor_liberal, 
  type = "trace", 
  which.items = dif_irt_mh_symptoms$DIF_stats%>% mutate(idx = row_number()) %>% filter(p_adj < 0.05)  %>% pull(idx)
  )

MMPI
#DIF with MMPI
dif_irt_mh_mmpi = DIF_test(
  items = mh_vars_num %>% select(
    Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen:I_get_all_the_sympathy_I_should
  ),
  model = 1,
  itemtype = "2PL",
  group = d$leftism_median_split,
  verbose = F
)
## There are 8 steps
## Step 1: Initial joint fit
## 
## Step 2: Initial MI fit
## 
## Step 3: Leave one out MI testing
## 
## Step 4: Fit without DIF items, liberal threshold
## 
## Step 5: Fit without DIF items, conservative threshold
## 
## Step 6: Fit with anchor items, liberal threshold
## 
## Step 7: Fit with anchor items, conservative threshold
## 
## Step 8: Get scores
#scale level gap and bias
SMD_matrix(d$p_mmpi, d$leftism_median_split)
##       High   Low
## High    NA 0.297
## Low  0.297    NA
dif_irt_mh_mmpi$effect_size_test
## $liberal
##           Effect Size   Value
## 1                STDS 0.04372
## 2                UTDS 0.51111
## 3              UETSDS 0.08560
## 4               ETSSD 0.00817
## 5         Starks.DTFR 0.03761
## 6               UDTFR 0.49567
## 7              UETSDN 0.07969
## 8 theta.of.max.test.D 1.06233
## 9           Test.Dmax 0.16718
## 
## $conservative
##           Effect Size   Value
## 1                STDS -0.0994
## 2                UTDS  0.3151
## 3              UETSDS  0.1526
## 4               ETSSD -0.0184
## 5         Starks.DTFR -0.1026
## 6               UDTFR  0.3044
## 7              UETSDN  0.1454
## 8 theta.of.max.test.D  0.4215
## 9           Test.Dmax -0.3298
#plot scale function
plot(
  dif_irt_mh_mmpi$fits$anchor_liberal,
  type = "score"
)

#what items are biased?
dif_irt_mh_mmpi$effect_size_items
## $liberal
##                                                                                                     SIDS
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                           -0.052
## Most_of_the_time_I_feel_blue                                                                       0.000
## I_often_feel_as_if_things_were_not_real                                                            0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                   0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                          0.000
## I_feel_that_I_have_often_been_punished_without_cause                                               0.036
## Life_is_a_strain_for_me_much_of_the_time                                                           0.000
## I_have_strange_and_peculiar_thoughts                                                               0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up            0.062
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything          0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to  0.058
## At_times_I_think_I_am_no_good_at_all                                                               0.000
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                     0.000
## I_am_happy_most_of_the_time                                                                       -0.067
## I_very_seldom_have_spells_of_the_blues                                                            -0.016
## During_the_past_few_years_I_have_been_well_most_of_the_time                                       -0.027
## My_daily_life_is_full_of_things_that_keep_me_interested                                            0.000
## I_am_usually_calm_and_not_easily_upset                                                             0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                           0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                   0.000
## I_am_liked_by_most_people_who_know_me                                                              0.050
## I_am_not_easily_angered                                                                            0.000
## I_do_not_mind_meeting_strangers                                                                    0.000
## I_get_all_the_sympathy_I_should                                                                    0.000
##                                                                                                    UIDS
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                           0.070
## Most_of_the_time_I_feel_blue                                                                      0.000
## I_often_feel_as_if_things_were_not_real                                                           0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                  0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                         0.000
## I_feel_that_I_have_often_been_punished_without_cause                                              0.044
## Life_is_a_strain_for_me_much_of_the_time                                                          0.000
## I_have_strange_and_peculiar_thoughts                                                              0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up           0.062
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything         0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to 0.058
## At_times_I_think_I_am_no_good_at_all                                                              0.000
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                    0.000
## I_am_happy_most_of_the_time                                                                       0.083
## I_very_seldom_have_spells_of_the_blues                                                            0.097
## During_the_past_few_years_I_have_been_well_most_of_the_time                                       0.048
## My_daily_life_is_full_of_things_that_keep_me_interested                                           0.000
## I_am_usually_calm_and_not_easily_upset                                                            0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                          0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                  0.000
## I_am_liked_by_most_people_who_know_me                                                             0.050
## I_am_not_easily_angered                                                                           0.000
## I_do_not_mind_meeting_strangers                                                                   0.000
## I_get_all_the_sympathy_I_should                                                                   0.000
##                                                                                                     SIDN
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                           -0.056
## Most_of_the_time_I_feel_blue                                                                       0.000
## I_often_feel_as_if_things_were_not_real                                                            0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                   0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                          0.000
## I_feel_that_I_have_often_been_punished_without_cause                                               0.034
## Life_is_a_strain_for_me_much_of_the_time                                                           0.000
## I_have_strange_and_peculiar_thoughts                                                               0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up            0.058
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything          0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to  0.057
## At_times_I_think_I_am_no_good_at_all                                                               0.000
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                     0.000
## I_am_happy_most_of_the_time                                                                       -0.063
## I_very_seldom_have_spells_of_the_blues                                                            -0.016
## During_the_past_few_years_I_have_been_well_most_of_the_time                                       -0.027
## My_daily_life_is_full_of_things_that_keep_me_interested                                            0.000
## I_am_usually_calm_and_not_easily_upset                                                             0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                           0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                   0.000
## I_am_liked_by_most_people_who_know_me                                                              0.051
## I_am_not_easily_angered                                                                            0.000
## I_do_not_mind_meeting_strangers                                                                    0.000
## I_get_all_the_sympathy_I_should                                                                    0.000
##                                                                                                    UIDN
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                           0.075
## Most_of_the_time_I_feel_blue                                                                      0.000
## I_often_feel_as_if_things_were_not_real                                                           0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                  0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                         0.000
## I_feel_that_I_have_often_been_punished_without_cause                                              0.041
## Life_is_a_strain_for_me_much_of_the_time                                                          0.000
## I_have_strange_and_peculiar_thoughts                                                              0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up           0.058
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything         0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to 0.057
## At_times_I_think_I_am_no_good_at_all                                                              0.000
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                    0.000
## I_am_happy_most_of_the_time                                                                       0.078
## I_very_seldom_have_spells_of_the_blues                                                            0.089
## During_the_past_few_years_I_have_been_well_most_of_the_time                                       0.047
## My_daily_life_is_full_of_things_that_keep_me_interested                                           0.000
## I_am_usually_calm_and_not_easily_upset                                                            0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                          0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                  0.000
## I_am_liked_by_most_people_who_know_me                                                             0.051
## I_am_not_easily_angered                                                                           0.000
## I_do_not_mind_meeting_strangers                                                                   0.000
## I_get_all_the_sympathy_I_should                                                                   0.000
##                                                                                                     ESSD
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                           -0.183
## Most_of_the_time_I_feel_blue                                                                       0.000
## I_often_feel_as_if_things_were_not_real                                                            0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                   0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                          0.000
## I_feel_that_I_have_often_been_punished_without_cause                                               0.149
## Life_is_a_strain_for_me_much_of_the_time                                                           0.000
## I_have_strange_and_peculiar_thoughts                                                               0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up            0.241
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything          0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to  0.301
## At_times_I_think_I_am_no_good_at_all                                                               0.000
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                     0.000
## I_am_happy_most_of_the_time                                                                       -0.254
## I_very_seldom_have_spells_of_the_blues                                                            -0.057
## During_the_past_few_years_I_have_been_well_most_of_the_time                                       -0.141
## My_daily_life_is_full_of_things_that_keep_me_interested                                            0.000
## I_am_usually_calm_and_not_easily_upset                                                             0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                           0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                   0.000
## I_am_liked_by_most_people_who_know_me                                                              0.452
## I_am_not_easily_angered                                                                            0.000
## I_do_not_mind_meeting_strangers                                                                    0.000
## I_get_all_the_sympathy_I_should                                                                    0.000
##                                                                                                   theta.of.max.D
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                                    0.026
## Most_of_the_time_I_feel_blue                                                                              -1.045
## I_often_feel_as_if_things_were_not_real                                                                   -1.045
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                          -1.045
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                                 -1.045
## I_feel_that_I_have_often_been_punished_without_cause                                                       1.010
## Life_is_a_strain_for_me_much_of_the_time                                                                  -1.045
## I_have_strange_and_peculiar_thoughts                                                                      -1.045
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                    0.797
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything                 -1.045
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to          1.054
## At_times_I_think_I_am_no_good_at_all                                                                      -1.045
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                            -1.045
## I_am_happy_most_of_the_time                                                                                0.922
## I_very_seldom_have_spells_of_the_blues                                                                     0.837
## During_the_past_few_years_I_have_been_well_most_of_the_time                                                1.482
## My_daily_life_is_full_of_things_that_keep_me_interested                                                   -1.045
## I_am_usually_calm_and_not_easily_upset                                                                    -1.045
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                                  -1.045
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                          -1.045
## I_am_liked_by_most_people_who_know_me                                                                      1.780
## I_am_not_easily_angered                                                                                   -1.045
## I_do_not_mind_meeting_strangers                                                                           -1.045
## I_get_all_the_sympathy_I_should                                                                           -1.045
##                                                                                                    max.D
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                           -0.152
## Most_of_the_time_I_feel_blue                                                                       0.000
## I_often_feel_as_if_things_were_not_real                                                            0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                   0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                          0.000
## I_feel_that_I_have_often_been_punished_without_cause                                               0.179
## Life_is_a_strain_for_me_much_of_the_time                                                           0.000
## I_have_strange_and_peculiar_thoughts                                                               0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up            0.206
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything          0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to  0.177
## At_times_I_think_I_am_no_good_at_all                                                               0.000
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                     0.000
## I_am_happy_most_of_the_time                                                                       -0.272
## I_very_seldom_have_spells_of_the_blues                                                            -0.182
## During_the_past_few_years_I_have_been_well_most_of_the_time                                       -0.197
## My_daily_life_is_full_of_things_that_keep_me_interested                                            0.000
## I_am_usually_calm_and_not_easily_upset                                                             0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                           0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                   0.000
## I_am_liked_by_most_people_who_know_me                                                              0.211
## I_am_not_easily_angered                                                                            0.000
## I_do_not_mind_meeting_strangers                                                                    0.000
## I_get_all_the_sympathy_I_should                                                                    0.000
##                                                                                                   mean.ES.foc
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                                 0.213
## Most_of_the_time_I_feel_blue                                                                            0.184
## I_often_feel_as_if_things_were_not_real                                                                 0.133
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                        0.191
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                               0.220
## I_feel_that_I_have_often_been_punished_without_cause                                                    0.206
## Life_is_a_strain_for_me_much_of_the_time                                                                0.242
## I_have_strange_and_peculiar_thoughts                                                                    0.242
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                 0.212
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything               0.188
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to       0.165
## At_times_I_think_I_am_no_good_at_all                                                                    0.240
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                          0.271
## I_am_happy_most_of_the_time                                                                             0.199
## I_very_seldom_have_spells_of_the_blues                                                                  0.366
## During_the_past_few_years_I_have_been_well_most_of_the_time                                             0.180
## My_daily_life_is_full_of_things_that_keep_me_interested                                                 0.206
## I_am_usually_calm_and_not_easily_upset                                                                  0.153
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                                0.158
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                        0.342
## I_am_liked_by_most_people_who_know_me                                                                   0.104
## I_am_not_easily_angered                                                                                 0.200
## I_do_not_mind_meeting_strangers                                                                         0.253
## I_get_all_the_sympathy_I_should                                                                         0.216
##                                                                                                   mean.ES.ref
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                                 0.264
## Most_of_the_time_I_feel_blue                                                                            0.184
## I_often_feel_as_if_things_were_not_real                                                                 0.133
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                        0.191
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                               0.220
## I_feel_that_I_have_often_been_punished_without_cause                                                    0.170
## Life_is_a_strain_for_me_much_of_the_time                                                                0.242
## I_have_strange_and_peculiar_thoughts                                                                    0.242
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                 0.150
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything               0.188
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to       0.107
## At_times_I_think_I_am_no_good_at_all                                                                    0.240
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                          0.271
## I_am_happy_most_of_the_time                                                                             0.266
## I_very_seldom_have_spells_of_the_blues                                                                  0.382
## During_the_past_few_years_I_have_been_well_most_of_the_time                                             0.208
## My_daily_life_is_full_of_things_that_keep_me_interested                                                 0.206
## I_am_usually_calm_and_not_easily_upset                                                                  0.153
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                                0.158
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                        0.342
## I_am_liked_by_most_people_who_know_me                                                                   0.054
## I_am_not_easily_angered                                                                                 0.200
## I_do_not_mind_meeting_strangers                                                                         0.253
## I_get_all_the_sympathy_I_should                                                                         0.216
## 
## $conservative
##                                                                                                     SIDS
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                           -0.058
## Most_of_the_time_I_feel_blue                                                                       0.000
## I_often_feel_as_if_things_were_not_real                                                            0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                   0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                          0.000
## I_feel_that_I_have_often_been_punished_without_cause                                               0.000
## Life_is_a_strain_for_me_much_of_the_time                                                           0.000
## I_have_strange_and_peculiar_thoughts                                                               0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up            0.056
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything          0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to  0.000
## At_times_I_think_I_am_no_good_at_all                                                               0.000
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                     0.000
## I_am_happy_most_of_the_time                                                                       -0.074
## I_very_seldom_have_spells_of_the_blues                                                            -0.023
## During_the_past_few_years_I_have_been_well_most_of_the_time                                        0.000
## My_daily_life_is_full_of_things_that_keep_me_interested                                            0.000
## I_am_usually_calm_and_not_easily_upset                                                             0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                           0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                   0.000
## I_am_liked_by_most_people_who_know_me                                                              0.000
## I_am_not_easily_angered                                                                            0.000
## I_do_not_mind_meeting_strangers                                                                    0.000
## I_get_all_the_sympathy_I_should                                                                    0.000
##                                                                                                    UIDS
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                           0.072
## Most_of_the_time_I_feel_blue                                                                      0.000
## I_often_feel_as_if_things_were_not_real                                                           0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                  0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                         0.000
## I_feel_that_I_have_often_been_punished_without_cause                                              0.000
## Life_is_a_strain_for_me_much_of_the_time                                                          0.000
## I_have_strange_and_peculiar_thoughts                                                              0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up           0.056
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything         0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to 0.000
## At_times_I_think_I_am_no_good_at_all                                                              0.000
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                    0.000
## I_am_happy_most_of_the_time                                                                       0.088
## I_very_seldom_have_spells_of_the_blues                                                            0.099
## During_the_past_few_years_I_have_been_well_most_of_the_time                                       0.000
## My_daily_life_is_full_of_things_that_keep_me_interested                                           0.000
## I_am_usually_calm_and_not_easily_upset                                                            0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                          0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                  0.000
## I_am_liked_by_most_people_who_know_me                                                             0.000
## I_am_not_easily_angered                                                                           0.000
## I_do_not_mind_meeting_strangers                                                                   0.000
## I_get_all_the_sympathy_I_should                                                                   0.000
##                                                                                                     SIDN
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                           -0.063
## Most_of_the_time_I_feel_blue                                                                       0.000
## I_often_feel_as_if_things_were_not_real                                                            0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                   0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                          0.000
## I_feel_that_I_have_often_been_punished_without_cause                                               0.000
## Life_is_a_strain_for_me_much_of_the_time                                                           0.000
## I_have_strange_and_peculiar_thoughts                                                               0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up            0.053
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything          0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to  0.000
## At_times_I_think_I_am_no_good_at_all                                                               0.000
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                     0.000
## I_am_happy_most_of_the_time                                                                       -0.070
## I_very_seldom_have_spells_of_the_blues                                                            -0.023
## During_the_past_few_years_I_have_been_well_most_of_the_time                                        0.000
## My_daily_life_is_full_of_things_that_keep_me_interested                                            0.000
## I_am_usually_calm_and_not_easily_upset                                                             0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                           0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                   0.000
## I_am_liked_by_most_people_who_know_me                                                              0.000
## I_am_not_easily_angered                                                                            0.000
## I_do_not_mind_meeting_strangers                                                                    0.000
## I_get_all_the_sympathy_I_should                                                                    0.000
##                                                                                                    UIDN
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                           0.078
## Most_of_the_time_I_feel_blue                                                                      0.000
## I_often_feel_as_if_things_were_not_real                                                           0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                  0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                         0.000
## I_feel_that_I_have_often_been_punished_without_cause                                              0.000
## Life_is_a_strain_for_me_much_of_the_time                                                          0.000
## I_have_strange_and_peculiar_thoughts                                                              0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up           0.053
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything         0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to 0.000
## At_times_I_think_I_am_no_good_at_all                                                              0.000
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                    0.000
## I_am_happy_most_of_the_time                                                                       0.082
## I_very_seldom_have_spells_of_the_blues                                                            0.091
## During_the_past_few_years_I_have_been_well_most_of_the_time                                       0.000
## My_daily_life_is_full_of_things_that_keep_me_interested                                           0.000
## I_am_usually_calm_and_not_easily_upset                                                            0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                          0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                  0.000
## I_am_liked_by_most_people_who_know_me                                                             0.000
## I_am_not_easily_angered                                                                           0.000
## I_do_not_mind_meeting_strangers                                                                   0.000
## I_get_all_the_sympathy_I_should                                                                   0.000
##                                                                                                     ESSD
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                           -0.203
## Most_of_the_time_I_feel_blue                                                                       0.000
## I_often_feel_as_if_things_were_not_real                                                            0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                   0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                          0.000
## I_feel_that_I_have_often_been_punished_without_cause                                               0.000
## Life_is_a_strain_for_me_much_of_the_time                                                           0.000
## I_have_strange_and_peculiar_thoughts                                                               0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up            0.214
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything          0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to  0.000
## At_times_I_think_I_am_no_good_at_all                                                               0.000
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                     0.000
## I_am_happy_most_of_the_time                                                                       -0.278
## I_very_seldom_have_spells_of_the_blues                                                            -0.080
## During_the_past_few_years_I_have_been_well_most_of_the_time                                        0.000
## My_daily_life_is_full_of_things_that_keep_me_interested                                            0.000
## I_am_usually_calm_and_not_easily_upset                                                             0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                           0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                   0.000
## I_am_liked_by_most_people_who_know_me                                                              0.000
## I_am_not_easily_angered                                                                            0.000
## I_do_not_mind_meeting_strangers                                                                    0.000
## I_get_all_the_sympathy_I_should                                                                    0.000
##                                                                                                   theta.of.max.D
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                                    0.071
## Most_of_the_time_I_feel_blue                                                                              -1.032
## I_often_feel_as_if_things_were_not_real                                                                   -1.032
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                          -1.032
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                                 -1.032
## I_feel_that_I_have_often_been_punished_without_cause                                                      -1.032
## Life_is_a_strain_for_me_much_of_the_time                                                                  -1.032
## I_have_strange_and_peculiar_thoughts                                                                      -1.032
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                    0.806
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything                 -1.032
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to         -1.032
## At_times_I_think_I_am_no_good_at_all                                                                      -1.032
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                            -1.032
## I_am_happy_most_of_the_time                                                                                0.917
## I_very_seldom_have_spells_of_the_blues                                                                     0.836
## During_the_past_few_years_I_have_been_well_most_of_the_time                                               -1.032
## My_daily_life_is_full_of_things_that_keep_me_interested                                                   -1.032
## I_am_usually_calm_and_not_easily_upset                                                                    -1.032
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                                  -1.032
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                          -1.032
## I_am_liked_by_most_people_who_know_me                                                                     -1.032
## I_am_not_easily_angered                                                                                   -1.032
## I_do_not_mind_meeting_strangers                                                                           -1.032
## I_get_all_the_sympathy_I_should                                                                           -1.032
##                                                                                                    max.D
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                           -0.161
## Most_of_the_time_I_feel_blue                                                                       0.000
## I_often_feel_as_if_things_were_not_real                                                            0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                   0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                          0.000
## I_feel_that_I_have_often_been_punished_without_cause                                               0.000
## Life_is_a_strain_for_me_much_of_the_time                                                           0.000
## I_have_strange_and_peculiar_thoughts                                                               0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up            0.180
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything          0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to  0.000
## At_times_I_think_I_am_no_good_at_all                                                               0.000
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                     0.000
## I_am_happy_most_of_the_time                                                                       -0.284
## I_very_seldom_have_spells_of_the_blues                                                            -0.190
## During_the_past_few_years_I_have_been_well_most_of_the_time                                        0.000
## My_daily_life_is_full_of_things_that_keep_me_interested                                            0.000
## I_am_usually_calm_and_not_easily_upset                                                             0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                           0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                   0.000
## I_am_liked_by_most_people_who_know_me                                                              0.000
## I_am_not_easily_angered                                                                            0.000
## I_do_not_mind_meeting_strangers                                                                    0.000
## I_get_all_the_sympathy_I_should                                                                    0.000
##                                                                                                   mean.ES.foc
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                                 0.213
## Most_of_the_time_I_feel_blue                                                                            0.188
## I_often_feel_as_if_things_were_not_real                                                                 0.136
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                        0.194
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                               0.224
## I_feel_that_I_have_often_been_punished_without_cause                                                    0.188
## Life_is_a_strain_for_me_much_of_the_time                                                                0.246
## I_have_strange_and_peculiar_thoughts                                                                    0.244
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                 0.212
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything               0.192
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to       0.136
## At_times_I_think_I_am_no_good_at_all                                                                    0.244
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                          0.274
## I_am_happy_most_of_the_time                                                                             0.199
## I_very_seldom_have_spells_of_the_blues                                                                  0.366
## During_the_past_few_years_I_have_been_well_most_of_the_time                                             0.201
## My_daily_life_is_full_of_things_that_keep_me_interested                                                 0.209
## I_am_usually_calm_and_not_easily_upset                                                                  0.156
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                                0.161
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                        0.345
## I_am_liked_by_most_people_who_know_me                                                                   0.078
## I_am_not_easily_angered                                                                                 0.203
## I_do_not_mind_meeting_strangers                                                                         0.255
## I_get_all_the_sympathy_I_should                                                                         0.219
##                                                                                                   mean.ES.ref
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                                 0.271
## Most_of_the_time_I_feel_blue                                                                            0.188
## I_often_feel_as_if_things_were_not_real                                                                 0.136
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                        0.194
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                               0.224
## I_feel_that_I_have_often_been_punished_without_cause                                                    0.188
## Life_is_a_strain_for_me_much_of_the_time                                                                0.246
## I_have_strange_and_peculiar_thoughts                                                                    0.244
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                 0.157
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything               0.192
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to       0.136
## At_times_I_think_I_am_no_good_at_all                                                                    0.244
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                          0.274
## I_am_happy_most_of_the_time                                                                             0.273
## I_very_seldom_have_spells_of_the_blues                                                                  0.388
## During_the_past_few_years_I_have_been_well_most_of_the_time                                             0.201
## My_daily_life_is_full_of_things_that_keep_me_interested                                                 0.209
## I_am_usually_calm_and_not_easily_upset                                                                  0.156
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                                0.161
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                        0.345
## I_am_liked_by_most_people_who_know_me                                                                   0.078
## I_am_not_easily_angered                                                                                 0.203
## I_do_not_mind_meeting_strangers                                                                         0.255
## I_get_all_the_sympathy_I_should                                                                         0.219
#plot item functions
plot_items(dif_irt_mh_mmpi)

Diagnoses only
#DIF with diagnoses
dif_irt_mh_diag = DIF_test(
  items = mh_vars_num %>% select(-all_of(mh_vars_symptoms)),
  model = 1,
  itemtype = mh_vars_options %>% slice(-mh_vars_symptoms_idx) %>% pull(itemtype),
  group = d$leftism_median_split,
  verbose = F
)
## There are 8 steps
## Step 1: Initial joint fit
## 
## Step 2: Initial MI fit
## 
## Step 3: Leave one out MI testing
## 
## Step 4: Fit without DIF items, liberal threshold
## 
## Step 5: Fit without DIF items, conservative threshold
## 
## Step 6: Fit with anchor items, liberal threshold
## 
## Step 7: Fit with anchor items, conservative threshold
## 
## Step 8: Get scores
#scale level gap and bias
SMD_matrix(d$p_diag, d$leftism_median_split)
##       High   Low
## High    NA 0.342
## Low  0.342    NA
dif_irt_mh_diag$effect_size_test
## $liberal
##           Effect Size     Value
## 1                STDS -0.000554
## 2                UTDS  0.082358
## 3              UETSDS  0.033918
## 4               ETSSD -0.000428
## 5         Starks.DTFR  0.015918
## 6               UDTFR  0.071404
## 7              UETSDN  0.026545
## 8 theta.of.max.test.D  3.234948
## 9           Test.Dmax -0.883177
## 
## $conservative
##           Effect Size Value
## 1                STDS  0.00
## 2                UTDS  0.00
## 3              UETSDS  0.00
## 4               ETSSD  0.00
## 5         Starks.DTFR  0.00
## 6               UDTFR  0.00
## 7              UETSDN  0.00
## 8 theta.of.max.test.D -1.37
## 9           Test.Dmax  0.00
#plot scale function
plot(
  dif_irt_mh_diag$fits$anchor_liberal,
  type = "score"
)

#what items are biased?
dif_irt_mh_diag$effect_size_items
## $liberal
##                                                 SIDS  UIDS   SIDN  UIDN   ESSD
## Attention_deficit_hyperactivity_disorder_ADHD -0.028 0.028 -0.023 0.023 -0.297
## Alcohol_abuse                                  0.000 0.000  0.000 0.000  0.000
## Non_alcohol_drug_abuse                         0.000 0.000  0.000 0.000  0.000
## Autism_spectrum_disorder_ASD                   0.000 0.000  0.000 0.000  0.000
## Anti_social_personality_disorder               0.000 0.000  0.000 0.000  0.000
## Bipolarity                                     0.000 0.000  0.000 0.000  0.000
## Borderline_Personality_Disorder                0.000 0.000  0.000 0.000  0.000
## Depression                                     0.000 0.000  0.000 0.000  0.000
## General_Anxiety_Disorder_GAD                   0.000 0.000  0.000 0.000  0.000
## Obsessive_compulsive_disorder_OCD             -0.007 0.021  0.004 0.014 -0.107
## Panic_disorder                                 0.000 0.000  0.000 0.000  0.000
## Paranoia_Paranoid_personality_disorder         0.000 0.000  0.000 0.000  0.000
## Phobias_social                                 0.000 0.000  0.000 0.000  0.000
## Specific_phobias                               0.000 0.000  0.000 0.000  0.000
## Post_traumatic_stress_disorder_PTSD            0.000 0.000  0.000 0.000  0.000
## Schizophrenia                                  0.000 0.000  0.000 0.000  0.000
## Schizoid_personality_disorder                  0.000 0.000  0.000 0.000  0.000
## Sleeping_disorders                             0.034 0.034  0.035 0.035  0.283
##                                               theta.of.max.D  max.D mean.ES.foc
## Attention_deficit_hyperactivity_disorder_ADHD           3.23 -0.243       0.057
## Alcohol_abuse                                          -1.47  0.000       0.032
## Non_alcohol_drug_abuse                                 -1.47  0.000       0.013
## Autism_spectrum_disorder_ASD                           -1.47  0.000       0.021
## Anti_social_personality_disorder                       -1.47  0.000       0.009
## Bipolarity                                             -1.47  0.000       0.026
## Borderline_Personality_Disorder                        -1.47  0.000       0.013
## Depression                                             -1.47  0.000       0.155
## General_Anxiety_Disorder_GAD                           -1.47  0.000       0.130
## Obsessive_compulsive_disorder_OCD                       3.23 -0.627       0.021
## Panic_disorder                                         -1.47  0.000       0.033
## Paranoia_Paranoid_personality_disorder                 -1.47  0.000       0.001
## Phobias_social                                         -1.47  0.000       0.011
## Specific_phobias                                       -1.47  0.000       0.011
## Post_traumatic_stress_disorder_PTSD                    -1.47  0.000       0.047
## Schizophrenia                                          -1.47  0.000       0.001
## Schizoid_personality_disorder                          -1.47  0.000       0.002
## Sleeping_disorders                                      1.28  0.124       0.078
##                                               mean.ES.ref
## Attention_deficit_hyperactivity_disorder_ADHD       0.085
## Alcohol_abuse                                       0.032
## Non_alcohol_drug_abuse                              0.013
## Autism_spectrum_disorder_ASD                        0.021
## Anti_social_personality_disorder                    0.009
## Bipolarity                                          0.026
## Borderline_Personality_Disorder                     0.013
## Depression                                          0.155
## General_Anxiety_Disorder_GAD                        0.130
## Obsessive_compulsive_disorder_OCD                   0.028
## Panic_disorder                                      0.033
## Paranoia_Paranoid_personality_disorder              0.001
## Phobias_social                                      0.011
## Specific_phobias                                    0.011
## Post_traumatic_stress_disorder_PTSD                 0.047
## Schizophrenia                                       0.001
## Schizoid_personality_disorder                       0.002
## Sleeping_disorders                                  0.045
## 
## $conservative
##                                               SIDS UIDS SIDN UIDN ESSD
## Attention_deficit_hyperactivity_disorder_ADHD    0    0    0    0    0
## Alcohol_abuse                                    0    0    0    0    0
## Non_alcohol_drug_abuse                           0    0    0    0    0
## Autism_spectrum_disorder_ASD                     0    0    0    0    0
## Anti_social_personality_disorder                 0    0    0    0    0
## Bipolarity                                       0    0    0    0    0
## Borderline_Personality_Disorder                  0    0    0    0    0
## Depression                                       0    0    0    0    0
## General_Anxiety_Disorder_GAD                     0    0    0    0    0
## Obsessive_compulsive_disorder_OCD                0    0    0    0    0
## Panic_disorder                                   0    0    0    0    0
## Paranoia_Paranoid_personality_disorder           0    0    0    0    0
## Phobias_social                                   0    0    0    0    0
## Specific_phobias                                 0    0    0    0    0
## Post_traumatic_stress_disorder_PTSD              0    0    0    0    0
## Schizophrenia                                    0    0    0    0    0
## Schizoid_personality_disorder                    0    0    0    0    0
## Sleeping_disorders                               0    0    0    0    0
##                                               theta.of.max.D max.D mean.ES.foc
## Attention_deficit_hyperactivity_disorder_ADHD          -1.37     0       0.075
## Alcohol_abuse                                          -1.37     0       0.032
## Non_alcohol_drug_abuse                                 -1.37     0       0.013
## Autism_spectrum_disorder_ASD                           -1.37     0       0.021
## Anti_social_personality_disorder                       -1.37     0       0.009
## Bipolarity                                             -1.37     0       0.026
## Borderline_Personality_Disorder                        -1.37     0       0.012
## Depression                                             -1.37     0       0.157
## General_Anxiety_Disorder_GAD                           -1.37     0       0.131
## Obsessive_compulsive_disorder_OCD                      -1.37     0       0.025
## Panic_disorder                                         -1.37     0       0.033
## Paranoia_Paranoid_personality_disorder                 -1.37     0       0.001
## Phobias_social                                         -1.37     0       0.011
## Specific_phobias                                       -1.37     0       0.011
## Post_traumatic_stress_disorder_PTSD                    -1.37     0       0.047
## Schizophrenia                                          -1.37     0       0.001
## Schizoid_personality_disorder                          -1.37     0       0.001
## Sleeping_disorders                                     -1.37     0       0.058
##                                               mean.ES.ref
## Attention_deficit_hyperactivity_disorder_ADHD       0.075
## Alcohol_abuse                                       0.032
## Non_alcohol_drug_abuse                              0.013
## Autism_spectrum_disorder_ASD                        0.021
## Anti_social_personality_disorder                    0.009
## Bipolarity                                          0.026
## Borderline_Personality_Disorder                     0.012
## Depression                                          0.157
## General_Anxiety_Disorder_GAD                        0.131
## Obsessive_compulsive_disorder_OCD                   0.025
## Panic_disorder                                      0.033
## Paranoia_Paranoid_personality_disorder              0.001
## Phobias_social                                      0.011
## Specific_phobias                                    0.011
## Post_traumatic_stress_disorder_PTSD                 0.047
## Schizophrenia                                       0.001
## Schizoid_personality_disorder                       0.001
## Sleeping_disorders                                  0.058
#plot item functions
plot_items(dif_irt_mh_diag)
## No items were biased
Life satisfaction
#DIF with life satisfaction
dif_irt_mh_satisfaction = DIF_test(
  items = mh_vars_num %>% select(Life_satisfaction:If_I_could_live_my_life_over_I_would_change_almost_nothing),
  model = 1,
  itemtype = "graded",
  group = d$leftism_median_split,
  verbose = F
)
## There are 8 steps
## Step 1: Initial joint fit
## 
## Step 2: Initial MI fit
## 
## Step 3: Leave one out MI testing
## 
## Step 4: Fit without DIF items, liberal threshold
## 
## Step 5: Fit without DIF items, conservative threshold
## 
## Step 6: Fit with anchor items, liberal threshold
## 
## Step 7: Fit with anchor items, conservative threshold
## 
## Step 8: Get scores
#scale level gap and bias
SMD_matrix(d$p_satisfaction, d$leftism_median_split)
##       High   Low
## High    NA 0.338
## Low  0.338    NA
dif_irt_mh_satisfaction$effect_size_test
## $liberal
##           Effect Size  Value
## 1                STDS 0.3005
## 2                UTDS 0.7209
## 3              UETSDS 0.3005
## 4               ETSSD 0.0206
## 5         Starks.DTFR 0.3099
## 6               UDTFR 0.7058
## 7              UETSDN 0.3100
## 8 theta.of.max.test.D 0.9240
## 9           Test.Dmax 0.4385
## 
## $conservative
##           Effect Size    Value
## 1                STDS  0.13716
## 2                UTDS  0.40448
## 3              UETSDS  0.13940
## 4               ETSSD  0.00942
## 5         Starks.DTFR  0.14350
## 6               UDTFR  0.39442
## 7              UETSDN  0.14449
## 8 theta.of.max.test.D -2.76115
## 9           Test.Dmax  0.28177
#plot scale function
plot(
  dif_irt_mh_satisfaction$fits$anchor_liberal,
  type = "score"
)

#what items are biased?
dif_irt_mh_satisfaction$effect_size_items
## $liberal
##                                                              SIDS  UIDS   SIDN
## Life_satisfaction                                           0.000 0.000  0.000
## Job_satisfaction                                            0.000 0.000  0.000
## Social_satisfaction                                         0.000 0.000  0.000
## Romantic_satisfaction                                      -0.045 0.139 -0.037
## Mood_higher_means_better_mood                               0.000 0.000  0.000
## Anxiety_levels_higher_means_less_anxious                    0.253 0.263  0.250
## In_most_ways_my_life_is_close_to_my_ideal                   0.000 0.000  0.000
## The_conditions_of_my_life_are_excellent                     0.000 0.000  0.000
## I_am_satisfied_with_my_life                                 0.000 0.000  0.000
## So_far_I_have_gotten_the_important_things_I_want_in_life    0.173 0.180  0.169
## If_I_could_live_my_life_over_I_would_change_almost_nothing -0.081 0.138 -0.072
##                                                             UIDN   ESSD
## Life_satisfaction                                          0.000  0.000
## Job_satisfaction                                           0.000  0.000
## Social_satisfaction                                        0.000  0.000
## Romantic_satisfaction                                      0.137 -0.033
## Mood_higher_means_better_mood                              0.000  0.000
## Anxiety_levels_higher_means_less_anxious                   0.257  0.322
## In_most_ways_my_life_is_close_to_my_ideal                  0.000  0.000
## The_conditions_of_my_life_are_excellent                    0.000  0.000
## I_am_satisfied_with_my_life                                0.000  0.000
## So_far_I_have_gotten_the_important_things_I_want_in_life   0.176  0.121
## If_I_could_live_my_life_over_I_would_change_almost_nothing 0.136 -0.056
##                                                            theta.of.max.D
## Life_satisfaction                                                  -0.958
## Job_satisfaction                                                   -0.958
## Social_satisfaction                                                -0.958
## Romantic_satisfaction                                               1.516
## Mood_higher_means_better_mood                                      -0.958
## Anxiety_levels_higher_means_less_anxious                           -2.572
## In_most_ways_my_life_is_close_to_my_ideal                          -0.958
## The_conditions_of_my_life_are_excellent                            -0.958
## I_am_satisfied_with_my_life                                        -0.958
## So_far_I_have_gotten_the_important_things_I_want_in_life           -0.548
## If_I_could_live_my_life_over_I_would_change_almost_nothing         -1.915
##                                                             max.D mean.ES.foc
## Life_satisfaction                                           0.000        1.89
## Job_satisfaction                                            0.000        2.39
## Social_satisfaction                                         0.000        2.26
## Romantic_satisfaction                                       0.319        2.25
## Mood_higher_means_better_mood                               0.000        1.92
## Anxiety_levels_higher_means_less_anxious                    0.470        2.86
## In_most_ways_my_life_is_close_to_my_ideal                   0.000        2.38
## The_conditions_of_my_life_are_excellent                     0.000        2.31
## I_am_satisfied_with_my_life                                 0.000        2.10
## So_far_I_have_gotten_the_important_things_I_want_in_life    0.249        2.19
## If_I_could_live_my_life_over_I_would_change_almost_nothing -0.226        2.93
##                                                            mean.ES.ref
## Life_satisfaction                                                 1.89
## Job_satisfaction                                                  2.39
## Social_satisfaction                                               2.26
## Romantic_satisfaction                                             2.30
## Mood_higher_means_better_mood                                     1.92
## Anxiety_levels_higher_means_less_anxious                          2.61
## In_most_ways_my_life_is_close_to_my_ideal                         2.38
## The_conditions_of_my_life_are_excellent                           2.31
## I_am_satisfied_with_my_life                                       2.10
## So_far_I_have_gotten_the_important_things_I_want_in_life          2.02
## If_I_could_live_my_life_over_I_would_change_almost_nothing        3.01
## 
## $conservative
##                                                              SIDS  UIDS   SIDN
## Life_satisfaction                                           0.000 0.000  0.000
## Job_satisfaction                                            0.000 0.000  0.000
## Social_satisfaction                                         0.000 0.000  0.000
## Romantic_satisfaction                                       0.000 0.000  0.000
## Mood_higher_means_better_mood                               0.000 0.000  0.000
## Anxiety_levels_higher_means_less_anxious                    0.240 0.249  0.237
## In_most_ways_my_life_is_close_to_my_ideal                   0.000 0.000  0.000
## The_conditions_of_my_life_are_excellent                     0.000 0.000  0.000
## I_am_satisfied_with_my_life                                 0.000 0.000  0.000
## So_far_I_have_gotten_the_important_things_I_want_in_life    0.000 0.000  0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing -0.103 0.155 -0.093
##                                                             UIDN   ESSD
## Life_satisfaction                                          0.000  0.000
## Job_satisfaction                                           0.000  0.000
## Social_satisfaction                                        0.000  0.000
## Romantic_satisfaction                                      0.000  0.000
## Mood_higher_means_better_mood                              0.000  0.000
## Anxiety_levels_higher_means_less_anxious                   0.244  0.306
## In_most_ways_my_life_is_close_to_my_ideal                  0.000  0.000
## The_conditions_of_my_life_are_excellent                    0.000  0.000
## I_am_satisfied_with_my_life                                0.000  0.000
## So_far_I_have_gotten_the_important_things_I_want_in_life   0.000  0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing 0.150 -0.071
##                                                            theta.of.max.D
## Life_satisfaction                                                   -0.93
## Job_satisfaction                                                    -0.93
## Social_satisfaction                                                 -0.93
## Romantic_satisfaction                                               -0.93
## Mood_higher_means_better_mood                                       -0.93
## Anxiety_levels_higher_means_less_anxious                            -2.56
## In_most_ways_my_life_is_close_to_my_ideal                           -0.93
## The_conditions_of_my_life_are_excellent                             -0.93
## I_am_satisfied_with_my_life                                         -0.93
## So_far_I_have_gotten_the_important_things_I_want_in_life            -0.93
## If_I_could_live_my_life_over_I_would_change_almost_nothing          -1.39
##                                                             max.D mean.ES.foc
## Life_satisfaction                                           0.000        1.90
## Job_satisfaction                                            0.000        2.39
## Social_satisfaction                                         0.000        2.27
## Romantic_satisfaction                                       0.000        2.27
## Mood_higher_means_better_mood                               0.000        1.92
## Anxiety_levels_higher_means_less_anxious                    0.451        2.86
## In_most_ways_my_life_is_close_to_my_ideal                   0.000        2.38
## The_conditions_of_my_life_are_excellent                     0.000        2.32
## I_am_satisfied_with_my_life                                 0.000        2.11
## So_far_I_have_gotten_the_important_things_I_want_in_life    0.000        2.12
## If_I_could_live_my_life_over_I_would_change_almost_nothing -0.253        2.93
##                                                            mean.ES.ref
## Life_satisfaction                                                 1.90
## Job_satisfaction                                                  2.39
## Social_satisfaction                                               2.27
## Romantic_satisfaction                                             2.27
## Mood_higher_means_better_mood                                     1.92
## Anxiety_levels_higher_means_less_anxious                          2.62
## In_most_ways_my_life_is_close_to_my_ideal                         2.38
## The_conditions_of_my_life_are_excellent                           2.32
## I_am_satisfied_with_my_life                                       2.11
## So_far_I_have_gotten_the_important_things_I_want_in_life          2.12
## If_I_could_live_my_life_over_I_would_change_almost_nothing        3.03
#plot item functions
plot_items(dif_irt_mh_satisfaction)

Last 2 weeks
#DIF with last 2 weeks
dif_irt_mh_last2weeks = DIF_test(
  items = mh_vars_num %>% select(Little_interest_or_pleasure_in_doing_things:Using_any_of_the_following_medicines_ON_YOUR_OWN),
  model = 1,
  itemtype = "graded",
  group = d$leftism_median_split,
  verbose = F
)
## There are 8 steps
## Step 1: Initial joint fit
## 
## Step 2: Initial MI fit
## 
## Step 3: Leave one out MI testing
## 
## Step 4: Fit without DIF items, liberal threshold
## 
## Step 5: Fit without DIF items, conservative threshold
## 
## Step 6: Fit with anchor items, liberal threshold
## 
## Step 7: Fit with anchor items, conservative threshold
## 
## Step 8: Get scores
#scale level gap and bias
SMD_matrix(d$p_last2weeks, d$leftism_median_split)
##       High   Low
## High    NA 0.199
## Low  0.199    NA
dif_irt_mh_last2weeks$effect_size_test
## $liberal
##           Effect Size  Value
## 1                STDS 0.3661
## 2                UTDS 2.1377
## 3              UETSDS 0.7336
## 4               ETSSD 0.0237
## 5         Starks.DTFR 0.3167
## 6               UDTFR 2.1017
## 7              UETSDN 0.7032
## 8 theta.of.max.test.D 2.2239
## 9           Test.Dmax 5.2846
## 
## $conservative
##           Effect Size  Value
## 1                STDS 0.2073
## 2                UTDS 1.4917
## 3              UETSDS 0.5031
## 4               ETSSD 0.0133
## 5         Starks.DTFR 0.1588
## 6               UDTFR 1.4569
## 7              UETSDN 0.4715
## 8 theta.of.max.test.D 2.2560
## 9           Test.Dmax 3.9121
#plot scale function
plot(
  dif_irt_mh_last2weeks$fits$anchor_liberal,
  type = "score"
)

#what items are biased?
dif_irt_mh_last2weeks$effect_size_items
## $liberal
##                                                                                                         SIDS
## Little_interest_or_pleasure_in_doing_things                                                            0.000
## Feeling_down_depressed_or_hopeless                                                                    -0.183
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                     0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                0.134
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                           0.180
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 -0.253
## Feeling_panic_or_being_frightened                                                                      0.000
## Avoiding_situations_that_make_you_anxious                                                              0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                          0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                       0.000
## Thoughts_of_actually_hurting_yourself                                                                  0.000
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                   0.243
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking  0.223
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                         -0.180
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home           0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                    0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                         0.117
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories        0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                           -0.177
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                             0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                      0.119
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                               0.211
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                      -0.068
##                                                                                                        UIDS
## Little_interest_or_pleasure_in_doing_things                                                           0.000
## Feeling_down_depressed_or_hopeless                                                                    0.184
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                    0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                               0.138
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                          0.180
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 0.253
## Feeling_panic_or_being_frightened                                                                     0.000
## Avoiding_situations_that_make_you_anxious                                                             0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                         0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                      0.000
## Thoughts_of_actually_hurting_yourself                                                                 0.000
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                  0.244
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking 0.224
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                         0.180
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home          0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                   0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                        0.117
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories       0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                           0.183
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                            0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                     0.129
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                              0.211
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                      0.096
##                                                                                                         SIDN
## Little_interest_or_pleasure_in_doing_things                                                            0.000
## Feeling_down_depressed_or_hopeless                                                                    -0.181
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                     0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                0.133
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                           0.177
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 -0.256
## Feeling_panic_or_being_frightened                                                                      0.000
## Avoiding_situations_that_make_you_anxious                                                              0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                          0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                       0.000
## Thoughts_of_actually_hurting_yourself                                                                  0.000
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                   0.228
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking  0.207
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                         -0.179
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home           0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                    0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                         0.114
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories        0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                           -0.181
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                             0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                      0.116
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                               0.210
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                      -0.071
##                                                                                                        UIDN
## Little_interest_or_pleasure_in_doing_things                                                           0.000
## Feeling_down_depressed_or_hopeless                                                                    0.182
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                    0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                               0.136
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                          0.177
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 0.256
## Feeling_panic_or_being_frightened                                                                     0.000
## Avoiding_situations_that_make_you_anxious                                                             0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                         0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                      0.000
## Thoughts_of_actually_hurting_yourself                                                                 0.000
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                  0.228
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking 0.208
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                         0.179
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home          0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                   0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                        0.114
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories       0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                           0.188
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                            0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                     0.125
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                              0.210
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                      0.098
##                                                                                                         ESSD
## Little_interest_or_pleasure_in_doing_things                                                            0.000
## Feeling_down_depressed_or_hopeless                                                                    -0.193
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                     0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                0.220
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                           0.332
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 -0.274
## Feeling_panic_or_being_frightened                                                                      0.000
## Avoiding_situations_that_make_you_anxious                                                              0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                          0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                       0.000
## Thoughts_of_actually_hurting_yourself                                                                  0.000
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                   0.546
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking  0.522
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                         -0.215
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home           0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                    0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                         0.182
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories        0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                           -0.222
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                             0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                      0.424
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                               0.616
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                      -0.179
##                                                                                                       theta.of.max.D
## Little_interest_or_pleasure_in_doing_things                                                                   -1.876
## Feeling_down_depressed_or_hopeless                                                                             1.628
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                            -1.876
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                        1.836
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                                   1.713
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                          1.075
## Feeling_panic_or_being_frightened                                                                             -1.876
## Avoiding_situations_that_make_you_anxious                                                                     -1.876
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                                 -1.876
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                              -1.876
## Thoughts_of_actually_hurting_yourself                                                                         -1.876
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                           2.224
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking          2.224
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                                  1.325
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home                  -1.876
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                           -1.876
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                                 1.215
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories               -1.876
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                                    0.437
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                                    -1.876
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                              2.224
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                                       2.224
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                               2.224
##                                                                                                        max.D
## Little_interest_or_pleasure_in_doing_things                                                            0.000
## Feeling_down_depressed_or_hopeless                                                                    -0.374
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                     0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                0.308
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                           0.454
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 -0.361
## Feeling_panic_or_being_frightened                                                                      0.000
## Avoiding_situations_that_make_you_anxious                                                              0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                          0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                       0.000
## Thoughts_of_actually_hurting_yourself                                                                  0.000
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                   1.819
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking  1.581
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                         -0.327
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home           0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                    0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                         0.351
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories        0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                           -0.350
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                             0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                      0.704
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                               0.572
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                       0.339
##                                                                                                       mean.ES.foc
## Little_interest_or_pleasure_in_doing_things                                                                 1.078
## Feeling_down_depressed_or_hopeless                                                                          0.942
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                          0.991
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                     1.041
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                                0.660
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                       0.963
## Feeling_panic_or_being_frightened                                                                           0.698
## Avoiding_situations_that_make_you_anxious                                                                   1.140
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                               0.921
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                            0.609
## Thoughts_of_actually_hurting_yourself                                                                       0.327
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                        0.352
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking       0.340
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                               1.091
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home                0.564
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                         0.553
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                              0.515
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories             0.504
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                                 0.528
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                                  0.776
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                           0.460
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                                    0.696
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                            0.347
##                                                                                                       mean.ES.ref
## Little_interest_or_pleasure_in_doing_things                                                                 1.078
## Feeling_down_depressed_or_hopeless                                                                          1.125
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                          0.991
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                     0.907
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                                0.480
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                       1.216
## Feeling_panic_or_being_frightened                                                                           0.698
## Avoiding_situations_that_make_you_anxious                                                                   1.140
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                               0.921
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                            0.609
## Thoughts_of_actually_hurting_yourself                                                                       0.327
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                        0.109
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking       0.117
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                               1.271
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home                0.564
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                         0.553
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                              0.397
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories             0.504
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                                 0.705
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                                  0.776
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                           0.342
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                                    0.485
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                            0.416
## 
## $conservative
##                                                                                                         SIDS
## Little_interest_or_pleasure_in_doing_things                                                            0.000
## Feeling_down_depressed_or_hopeless                                                                    -0.192
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                     0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                0.000
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                           0.175
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 -0.261
## Feeling_panic_or_being_frightened                                                                      0.000
## Avoiding_situations_that_make_you_anxious                                                              0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                          0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                       0.000
## Thoughts_of_actually_hurting_yourself                                                                  0.000
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                   0.241
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking  0.221
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                          0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home           0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                    0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                         0.000
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories        0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                           -0.186
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                             0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                      0.000
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                               0.210
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                       0.000
##                                                                                                        UIDS
## Little_interest_or_pleasure_in_doing_things                                                           0.000
## Feeling_down_depressed_or_hopeless                                                                    0.193
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                    0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                               0.000
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                          0.175
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 0.261
## Feeling_panic_or_being_frightened                                                                     0.000
## Avoiding_situations_that_make_you_anxious                                                             0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                         0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                      0.000
## Thoughts_of_actually_hurting_yourself                                                                 0.000
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                  0.241
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking 0.221
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                         0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home          0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                   0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                        0.000
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories       0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                           0.190
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                            0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                     0.000
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                              0.210
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                      0.000
##                                                                                                         SIDN
## Little_interest_or_pleasure_in_doing_things                                                            0.000
## Feeling_down_depressed_or_hopeless                                                                    -0.190
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                     0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                0.000
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                           0.172
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 -0.265
## Feeling_panic_or_being_frightened                                                                      0.000
## Avoiding_situations_that_make_you_anxious                                                              0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                          0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                       0.000
## Thoughts_of_actually_hurting_yourself                                                                  0.000
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                   0.222
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking  0.202
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                          0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home           0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                    0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                         0.000
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories        0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                           -0.191
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                             0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                      0.000
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                               0.208
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                       0.000
##                                                                                                        UIDN
## Little_interest_or_pleasure_in_doing_things                                                           0.000
## Feeling_down_depressed_or_hopeless                                                                    0.191
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                    0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                               0.000
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                          0.172
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 0.265
## Feeling_panic_or_being_frightened                                                                     0.000
## Avoiding_situations_that_make_you_anxious                                                             0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                         0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                      0.000
## Thoughts_of_actually_hurting_yourself                                                                 0.000
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                  0.222
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking 0.203
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                         0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home          0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                   0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                        0.000
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories       0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                           0.196
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                            0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                     0.000
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                              0.208
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                      0.000
##                                                                                                         ESSD
## Little_interest_or_pleasure_in_doing_things                                                            0.000
## Feeling_down_depressed_or_hopeless                                                                    -0.202
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                     0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                0.000
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                           0.321
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 -0.281
## Feeling_panic_or_being_frightened                                                                      0.000
## Avoiding_situations_that_make_you_anxious                                                              0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                          0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                       0.000
## Thoughts_of_actually_hurting_yourself                                                                  0.000
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                   0.541
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking  0.516
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                          0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home           0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                    0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                         0.000
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories        0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                           -0.232
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                             0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                      0.000
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                               0.610
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                       0.000
##                                                                                                       theta.of.max.D
## Little_interest_or_pleasure_in_doing_things                                                                   -1.887
## Feeling_down_depressed_or_hopeless                                                                             1.618
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                            -1.887
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                       -1.887
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                                   1.642
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                          1.094
## Feeling_panic_or_being_frightened                                                                             -1.887
## Avoiding_situations_that_make_you_anxious                                                                     -1.887
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                                 -1.887
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                              -1.887
## Thoughts_of_actually_hurting_yourself                                                                         -1.887
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                           2.256
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking          2.256
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                                 -1.887
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home                  -1.887
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                           -1.887
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                                -1.887
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories               -1.887
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                                    0.472
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                                    -1.887
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                             -1.887
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                                       2.256
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                              -1.887
##                                                                                                        max.D
## Little_interest_or_pleasure_in_doing_things                                                            0.000
## Feeling_down_depressed_or_hopeless                                                                    -0.395
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                     0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                0.000
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                           0.423
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 -0.380
## Feeling_panic_or_being_frightened                                                                      0.000
## Avoiding_situations_that_make_you_anxious                                                              0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                          0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                       0.000
## Thoughts_of_actually_hurting_yourself                                                                  0.000
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                   1.777
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking  1.541
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                          0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home           0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                    0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                         0.000
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories        0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                           -0.366
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                             0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                      0.000
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                               0.536
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                       0.000
##                                                                                                       mean.ES.foc
## Little_interest_or_pleasure_in_doing_things                                                                 1.083
## Feeling_down_depressed_or_hopeless                                                                          0.942
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                          0.995
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                     0.975
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                                0.660
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                       0.963
## Feeling_panic_or_being_frightened                                                                           0.704
## Avoiding_situations_that_make_you_anxious                                                                   1.143
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                               0.925
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                            0.614
## Thoughts_of_actually_hurting_yourself                                                                       0.332
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                        0.352
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking       0.341
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                               1.189
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home                0.568
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                         0.558
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                              0.457
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories             0.510
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                                 0.528
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                                  0.782
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                           0.397
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                                    0.696
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                            0.382
##                                                                                                       mean.ES.ref
## Little_interest_or_pleasure_in_doing_things                                                                 1.083
## Feeling_down_depressed_or_hopeless                                                                          1.134
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                          0.995
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                     0.975
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                                0.485
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                       1.224
## Feeling_panic_or_being_frightened                                                                           0.704
## Avoiding_situations_that_make_you_anxious                                                                   1.143
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                               0.925
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                            0.614
## Thoughts_of_actually_hurting_yourself                                                                       0.332
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                        0.111
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking       0.120
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                               1.189
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home                0.568
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                         0.558
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                              0.457
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories             0.510
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                                 0.714
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                                  0.782
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                           0.397
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                                    0.487
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                            0.382
#plot item functions
plot_items(dif_irt_mh_last2weeks)

Table of results

Calculate gaps on each scale, then calculate the size of the bias, and the number of biased items.

#table of results
tibble(
  scale = c("All items", "Non-diagnoses", "Diagnoses", "MMPI", "Last 2 weeks", "Satisfaction"),
  d = c(
    SMD_matrix(d$p_all, d$leftism_median_split)[1, 2],
    SMD_matrix(d$p_symptoms, d$leftism_median_split)[1, 2],
    SMD_matrix(d$p_diag, d$leftism_median_split)[1, 2],
    SMD_matrix(d$p_mmpi, d$leftism_median_split)[1, 2],
    SMD_matrix(d$p_last2weeks, d$leftism_median_split)[1, 2],
    SMD_matrix(d$p_satisfaction, d$leftism_median_split)[1, 2]
  ),
  bias_strict = c(
    dif_irt_mh_all$effect_size_test$conservative$Value[4],
    dif_irt_mh_symptoms$effect_size_test$conservative$Value[4],
    dif_irt_mh_diag$effect_size_test$conservative$Value[4],
    dif_irt_mh_mmpi$effect_size_test$conservative$Value[4],
    dif_irt_mh_last2weeks$effect_size_test$conservative$Value[4],
    dif_irt_mh_satisfaction$effect_size_test$conservative$Value[4]
  ),
  bias_lenient = c(
    dif_irt_mh_all$effect_size_test$liberal$Value[4],
    dif_irt_mh_symptoms$effect_size_test$liberal$Value[4],
    dif_irt_mh_diag$effect_size_test$liberal$Value[4],
    dif_irt_mh_mmpi$effect_size_test$liberal$Value[4],
    dif_irt_mh_last2weeks$effect_size_test$liberal$Value[4],
    dif_irt_mh_satisfaction$effect_size_test$liberal$Value[4]
  ),
  biased_items_strict = c(
    get_DIF_counts(dif_irt_mh_all, strict = T),
    get_DIF_counts(dif_irt_mh_symptoms, strict = T),
    get_DIF_counts(dif_irt_mh_diag, strict = T),
    get_DIF_counts(dif_irt_mh_mmpi, strict = T),
    get_DIF_counts(dif_irt_mh_last2weeks, strict = T),
    get_DIF_counts(dif_irt_mh_satisfaction, strict = T)
  ),
  biased_items_lenient = c(
    get_DIF_counts(dif_irt_mh_all, strict = F),
    get_DIF_counts(dif_irt_mh_symptoms, strict = F),
    get_DIF_counts(dif_irt_mh_diag, strict = F),
    get_DIF_counts(dif_irt_mh_mmpi, strict = F),
    get_DIF_counts(dif_irt_mh_last2weeks, strict = F),
    get_DIF_counts(dif_irt_mh_satisfaction, strict = F)
  ),
  item_count = c(
    nrow(dif_irt_mh_all$DIF_stats),
    nrow(dif_irt_mh_symptoms$DIF_stats),
    nrow(dif_irt_mh_diag$DIF_stats),
    nrow(dif_irt_mh_mmpi$DIF_stats),
    nrow(dif_irt_mh_last2weeks$DIF_stats),
    nrow(dif_irt_mh_satisfaction$DIF_stats)
  )
)

Age / sex

Age
#DIF with all items
dif_irt_mh_all_age = DIF_test(
  items = mh_vars_num,
  model = 1,
  itemtype = mh_vars_options$itemtype,
  group = d$age_median_split,
  verbose = F
)
## There are 8 steps
## Step 1: Initial joint fit
## 
## Step 2: Initial MI fit
## 
## Step 3: Leave one out MI testing
## 
## Step 4: Fit without DIF items, liberal threshold
## 
## Step 5: Fit without DIF items, conservative threshold
## 
## Step 6: Fit with anchor items, liberal threshold
## 
## Step 7: Fit with anchor items, conservative threshold
## 
## Step 8: Get scores
#scale level gap and bias
SMD_matrix(d$p_all, d$age_median_split)
##          Old  Young
## Old       NA -0.408
## Young -0.408     NA
dif_irt_mh_all_age$effect_size_test
## $liberal
##           Effect Size   Value
## 1                STDS -1.4189
## 2                UTDS  3.8017
## 3              UETSDS  1.5265
## 4               ETSSD -0.0409
## 5         Starks.DTFR -1.4390
## 6               UDTFR  3.8001
## 7              UETSDN  1.5532
## 8 theta.of.max.test.D -0.8513
## 9           Test.Dmax -2.2910
## 
## $conservative
##           Effect Size   Value
## 1                STDS 0.33194
## 2                UTDS 0.33377
## 3              UETSDS 0.33194
## 4               ETSSD 0.00954
## 5         Starks.DTFR 0.32714
## 6               UDTFR 0.32875
## 7              UETSDN 0.32716
## 8 theta.of.max.test.D 1.33827
## 9           Test.Dmax 0.59469
#plot scale function
plot(
  dif_irt_mh_all_age$fits$anchor_liberal,
  type = "score"
)

#what items are biased?
dif_irt_mh_all_age$effect_size_items
## $liberal
##                                                                                                         SIDS
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               -0.004
## Most_of_the_time_I_feel_blue                                                                           0.000
## I_often_feel_as_if_things_were_not_real                                                                0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                       0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                              0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                   0.000
## Life_is_a_strain_for_me_much_of_the_time                                                               0.000
## I_have_strange_and_peculiar_thoughts                                                                   0.148
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                0.000
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything              0.055
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to      0.000
## At_times_I_think_I_am_no_good_at_all                                                                   0.107
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                         0.080
## I_am_happy_most_of_the_time                                                                            0.000
## I_very_seldom_have_spells_of_the_blues                                                                 0.063
## During_the_past_few_years_I_have_been_well_most_of_the_time                                            0.049
## My_daily_life_is_full_of_things_that_keep_me_interested                                                0.000
## I_am_usually_calm_and_not_easily_upset                                                                 0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                               0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                       0.000
## I_am_liked_by_most_people_who_know_me                                                                  0.000
## I_am_not_easily_angered                                                                                0.000
## I_do_not_mind_meeting_strangers                                                                        0.000
## I_get_all_the_sympathy_I_should                                                                        0.000
## Little_interest_or_pleasure_in_doing_things                                                           -0.021
## Feeling_down_depressed_or_hopeless                                                                     0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                     0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                0.000
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                           0.000
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                  0.093
## Feeling_panic_or_being_frightened                                                                     -0.033
## Avoiding_situations_that_make_you_anxious                                                              0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                         -0.222
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                      -0.106
## Thoughts_of_actually_hurting_yourself                                                                  0.000
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                   0.000
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking  0.000
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                         -0.249
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home           0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                    0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                         0.000
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories        0.070
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                            0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                             0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                      0.000
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                               0.000
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                       0.000
## Life_satisfaction                                                                                     -0.078
## Job_satisfaction                                                                                       0.000
## Social_satisfaction                                                                                    0.000
## Romantic_satisfaction                                                                                 -0.327
## Mood_higher_means_better_mood                                                                          0.000
## Anxiety_levels_higher_means_less_anxious                                                               0.052
## In_most_ways_my_life_is_close_to_my_ideal                                                             -0.247
## The_conditions_of_my_life_are_excellent                                                               -0.329
## I_am_satisfied_with_my_life                                                                           -0.305
## So_far_I_have_gotten_the_important_things_I_want_in_life                                               0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                            -0.347
## Attention_deficit_hyperactivity_disorder_ADHD                                                          0.071
## Alcohol_abuse                                                                                          0.000
## Non_alcohol_drug_abuse                                                                                 0.000
## Autism_spectrum_disorder_ASD                                                                           0.040
## Anti_social_personality_disorder                                                                       0.000
## Bipolarity                                                                                             0.000
## Borderline_Personality_Disorder                                                                        0.000
## Depression                                                                                             0.000
## General_Anxiety_Disorder_GAD                                                                           0.089
## Obsessive_compulsive_disorder_OCD                                                                      0.000
## Panic_disorder                                                                                         0.000
## Paranoia_Paranoid_personality_disorder                                                                 0.000
## Phobias_social                                                                                         0.000
## Specific_phobias                                                                                       0.000
## Post_traumatic_stress_disorder_PTSD                                                                   -0.001
## Schizophrenia                                                                                          0.000
## Schizoid_personality_disorder                                                                          0.000
## Sleeping_disorders                                                                                    -0.068
##                                                                                                        UIDS
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               0.062
## Most_of_the_time_I_feel_blue                                                                          0.000
## I_often_feel_as_if_things_were_not_real                                                               0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                      0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                             0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                  0.000
## Life_is_a_strain_for_me_much_of_the_time                                                              0.000
## I_have_strange_and_peculiar_thoughts                                                                  0.149
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up               0.000
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything             0.059
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to     0.000
## At_times_I_think_I_am_no_good_at_all                                                                  0.107
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                        0.080
## I_am_happy_most_of_the_time                                                                           0.000
## I_very_seldom_have_spells_of_the_blues                                                                0.063
## During_the_past_few_years_I_have_been_well_most_of_the_time                                           0.086
## My_daily_life_is_full_of_things_that_keep_me_interested                                               0.000
## I_am_usually_calm_and_not_easily_upset                                                                0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                              0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                      0.000
## I_am_liked_by_most_people_who_know_me                                                                 0.000
## I_am_not_easily_angered                                                                               0.000
## I_do_not_mind_meeting_strangers                                                                       0.000
## I_get_all_the_sympathy_I_should                                                                       0.000
## Little_interest_or_pleasure_in_doing_things                                                           0.058
## Feeling_down_depressed_or_hopeless                                                                    0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                    0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                               0.000
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                          0.000
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 0.093
## Feeling_panic_or_being_frightened                                                                     0.091
## Avoiding_situations_that_make_you_anxious                                                             0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                         0.222
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                      0.141
## Thoughts_of_actually_hurting_yourself                                                                 0.000
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                  0.000
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking 0.000
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                         0.249
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home          0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                   0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                        0.000
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories       0.114
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                           0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                            0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                     0.000
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                              0.000
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                      0.000
## Life_satisfaction                                                                                     0.078
## Job_satisfaction                                                                                      0.000
## Social_satisfaction                                                                                   0.000
## Romantic_satisfaction                                                                                 0.327
## Mood_higher_means_better_mood                                                                         0.000
## Anxiety_levels_higher_means_less_anxious                                                              0.275
## In_most_ways_my_life_is_close_to_my_ideal                                                             0.255
## The_conditions_of_my_life_are_excellent                                                               0.329
## I_am_satisfied_with_my_life                                                                           0.305
## So_far_I_have_gotten_the_important_things_I_want_in_life                                              0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                            0.347
## Attention_deficit_hyperactivity_disorder_ADHD                                                         0.071
## Alcohol_abuse                                                                                         0.000
## Non_alcohol_drug_abuse                                                                                0.000
## Autism_spectrum_disorder_ASD                                                                          0.041
## Anti_social_personality_disorder                                                                      0.000
## Bipolarity                                                                                            0.000
## Borderline_Personality_Disorder                                                                       0.000
## Depression                                                                                            0.000
## General_Anxiety_Disorder_GAD                                                                          0.090
## Obsessive_compulsive_disorder_OCD                                                                     0.000
## Panic_disorder                                                                                        0.000
## Paranoia_Paranoid_personality_disorder                                                                0.000
## Phobias_social                                                                                        0.000
## Specific_phobias                                                                                      0.000
## Post_traumatic_stress_disorder_PTSD                                                                   0.040
## Schizophrenia                                                                                         0.000
## Schizoid_personality_disorder                                                                         0.000
## Sleeping_disorders                                                                                    0.068
##                                                                                                         SIDN
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               -0.008
## Most_of_the_time_I_feel_blue                                                                           0.000
## I_often_feel_as_if_things_were_not_real                                                                0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                       0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                              0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                   0.000
## Life_is_a_strain_for_me_much_of_the_time                                                               0.000
## I_have_strange_and_peculiar_thoughts                                                                   0.145
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                0.000
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything              0.056
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to      0.000
## At_times_I_think_I_am_no_good_at_all                                                                   0.104
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                         0.079
## I_am_happy_most_of_the_time                                                                            0.000
## I_very_seldom_have_spells_of_the_blues                                                                 0.064
## During_the_past_few_years_I_have_been_well_most_of_the_time                                            0.046
## My_daily_life_is_full_of_things_that_keep_me_interested                                                0.000
## I_am_usually_calm_and_not_easily_upset                                                                 0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                               0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                       0.000
## I_am_liked_by_most_people_who_know_me                                                                  0.000
## I_am_not_easily_angered                                                                                0.000
## I_do_not_mind_meeting_strangers                                                                        0.000
## I_get_all_the_sympathy_I_should                                                                        0.000
## Little_interest_or_pleasure_in_doing_things                                                           -0.018
## Feeling_down_depressed_or_hopeless                                                                     0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                     0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                0.000
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                           0.000
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                  0.092
## Feeling_panic_or_being_frightened                                                                     -0.028
## Avoiding_situations_that_make_you_anxious                                                              0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                         -0.222
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                      -0.107
## Thoughts_of_actually_hurting_yourself                                                                  0.000
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                   0.000
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking  0.000
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                         -0.249
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home           0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                    0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                         0.000
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories        0.071
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                            0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                             0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                      0.000
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                               0.000
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                       0.000
## Life_satisfaction                                                                                     -0.077
## Job_satisfaction                                                                                       0.000
## Social_satisfaction                                                                                    0.000
## Romantic_satisfaction                                                                                 -0.330
## Mood_higher_means_better_mood                                                                          0.000
## Anxiety_levels_higher_means_less_anxious                                                               0.049
## In_most_ways_my_life_is_close_to_my_ideal                                                             -0.250
## The_conditions_of_my_life_are_excellent                                                               -0.331
## I_am_satisfied_with_my_life                                                                           -0.305
## So_far_I_have_gotten_the_important_things_I_want_in_life                                               0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                            -0.350
## Attention_deficit_hyperactivity_disorder_ADHD                                                          0.071
## Alcohol_abuse                                                                                          0.000
## Non_alcohol_drug_abuse                                                                                 0.000
## Autism_spectrum_disorder_ASD                                                                           0.040
## Anti_social_personality_disorder                                                                       0.000
## Bipolarity                                                                                             0.000
## Borderline_Personality_Disorder                                                                        0.000
## Depression                                                                                             0.000
## General_Anxiety_Disorder_GAD                                                                           0.088
## Obsessive_compulsive_disorder_OCD                                                                      0.000
## Panic_disorder                                                                                         0.000
## Paranoia_Paranoid_personality_disorder                                                                 0.000
## Phobias_social                                                                                         0.000
## Specific_phobias                                                                                       0.000
## Post_traumatic_stress_disorder_PTSD                                                                   -0.001
## Schizophrenia                                                                                          0.000
## Schizoid_personality_disorder                                                                          0.000
## Sleeping_disorders                                                                                    -0.067
##                                                                                                        UIDN
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               0.061
## Most_of_the_time_I_feel_blue                                                                          0.000
## I_often_feel_as_if_things_were_not_real                                                               0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                      0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                             0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                  0.000
## Life_is_a_strain_for_me_much_of_the_time                                                              0.000
## I_have_strange_and_peculiar_thoughts                                                                  0.146
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up               0.000
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything             0.061
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to     0.000
## At_times_I_think_I_am_no_good_at_all                                                                  0.104
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                        0.079
## I_am_happy_most_of_the_time                                                                           0.000
## I_very_seldom_have_spells_of_the_blues                                                                0.064
## During_the_past_few_years_I_have_been_well_most_of_the_time                                           0.083
## My_daily_life_is_full_of_things_that_keep_me_interested                                               0.000
## I_am_usually_calm_and_not_easily_upset                                                                0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                              0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                      0.000
## I_am_liked_by_most_people_who_know_me                                                                 0.000
## I_am_not_easily_angered                                                                               0.000
## I_do_not_mind_meeting_strangers                                                                       0.000
## I_get_all_the_sympathy_I_should                                                                       0.000
## Little_interest_or_pleasure_in_doing_things                                                           0.055
## Feeling_down_depressed_or_hopeless                                                                    0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                    0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                               0.000
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                          0.000
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 0.092
## Feeling_panic_or_being_frightened                                                                     0.089
## Avoiding_situations_that_make_you_anxious                                                             0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                         0.222
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                      0.145
## Thoughts_of_actually_hurting_yourself                                                                 0.000
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                  0.000
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking 0.000
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                         0.249
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home          0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                   0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                        0.000
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories       0.119
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                           0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                            0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                     0.000
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                              0.000
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                      0.000
## Life_satisfaction                                                                                     0.077
## Job_satisfaction                                                                                      0.000
## Social_satisfaction                                                                                   0.000
## Romantic_satisfaction                                                                                 0.330
## Mood_higher_means_better_mood                                                                         0.000
## Anxiety_levels_higher_means_less_anxious                                                              0.268
## In_most_ways_my_life_is_close_to_my_ideal                                                             0.258
## The_conditions_of_my_life_are_excellent                                                               0.331
## I_am_satisfied_with_my_life                                                                           0.305
## So_far_I_have_gotten_the_important_things_I_want_in_life                                              0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                            0.350
## Attention_deficit_hyperactivity_disorder_ADHD                                                         0.071
## Alcohol_abuse                                                                                         0.000
## Non_alcohol_drug_abuse                                                                                0.000
## Autism_spectrum_disorder_ASD                                                                          0.040
## Anti_social_personality_disorder                                                                      0.000
## Bipolarity                                                                                            0.000
## Borderline_Personality_Disorder                                                                       0.000
## Depression                                                                                            0.000
## General_Anxiety_Disorder_GAD                                                                          0.088
## Obsessive_compulsive_disorder_OCD                                                                     0.000
## Panic_disorder                                                                                        0.000
## Paranoia_Paranoid_personality_disorder                                                                0.000
## Phobias_social                                                                                        0.000
## Specific_phobias                                                                                      0.000
## Post_traumatic_stress_disorder_PTSD                                                                   0.042
## Schizophrenia                                                                                         0.000
## Schizoid_personality_disorder                                                                         0.000
## Sleeping_disorders                                                                                    0.067
##                                                                                                         ESSD
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               -0.012
## Most_of_the_time_I_feel_blue                                                                           0.000
## I_often_feel_as_if_things_were_not_real                                                                0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                       0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                              0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                   0.000
## Life_is_a_strain_for_me_much_of_the_time                                                               0.000
## I_have_strange_and_peculiar_thoughts                                                                   0.689
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                0.000
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything              0.211
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to      0.000
## At_times_I_think_I_am_no_good_at_all                                                                   0.347
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                         0.308
## I_am_happy_most_of_the_time                                                                            0.000
## I_very_seldom_have_spells_of_the_blues                                                                 0.238
## During_the_past_few_years_I_have_been_well_most_of_the_time                                            0.218
## My_daily_life_is_full_of_things_that_keep_me_interested                                                0.000
## I_am_usually_calm_and_not_easily_upset                                                                 0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                               0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                       0.000
## I_am_liked_by_most_people_who_know_me                                                                  0.000
## I_am_not_easily_angered                                                                                0.000
## I_do_not_mind_meeting_strangers                                                                        0.000
## I_get_all_the_sympathy_I_should                                                                        0.000
## Little_interest_or_pleasure_in_doing_things                                                           -0.022
## Feeling_down_depressed_or_hopeless                                                                     0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                     0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                0.000
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                           0.000
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                  0.096
## Feeling_panic_or_being_frightened                                                                     -0.034
## Avoiding_situations_that_make_you_anxious                                                              0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                         -0.299
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                      -0.130
## Thoughts_of_actually_hurting_yourself                                                                  0.000
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                   0.000
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking  0.000
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                         -0.278
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home           0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                    0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                         0.000
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories        0.090
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                            0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                             0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                      0.000
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                               0.000
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                       0.000
## Life_satisfaction                                                                                     -0.064
## Job_satisfaction                                                                                       0.000
## Social_satisfaction                                                                                    0.000
## Romantic_satisfaction                                                                                 -0.303
## Mood_higher_means_better_mood                                                                          0.000
## Anxiety_levels_higher_means_less_anxious                                                               0.065
## In_most_ways_my_life_is_close_to_my_ideal                                                             -0.198
## The_conditions_of_my_life_are_excellent                                                               -0.275
## I_am_satisfied_with_my_life                                                                           -0.228
## So_far_I_have_gotten_the_important_things_I_want_in_life                                               0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                            -0.322
## Attention_deficit_hyperactivity_disorder_ADHD                                                          1.092
## Alcohol_abuse                                                                                          0.000
## Non_alcohol_drug_abuse                                                                                 0.000
## Autism_spectrum_disorder_ASD                                                                           1.367
## Anti_social_personality_disorder                                                                       0.000
## Bipolarity                                                                                             0.000
## Borderline_Personality_Disorder                                                                        0.000
## Depression                                                                                             0.000
## General_Anxiety_Disorder_GAD                                                                           0.600
## Obsessive_compulsive_disorder_OCD                                                                      0.000
## Panic_disorder                                                                                         0.000
## Paranoia_Paranoid_personality_disorder                                                                 0.000
## Phobias_social                                                                                         0.000
## Specific_phobias                                                                                       0.000
## Post_traumatic_stress_disorder_PTSD                                                                   -0.007
## Schizophrenia                                                                                          0.000
## Schizoid_personality_disorder                                                                          0.000
## Sleeping_disorders                                                                                    -0.645
##                                                                                                       theta.of.max.D
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                                        1.569
## Most_of_the_time_I_feel_blue                                                                                  -0.899
## I_often_feel_as_if_things_were_not_real                                                                       -0.899
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                              -0.899
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                                     -0.899
## I_feel_that_I_have_often_been_punished_without_cause                                                          -0.899
## Life_is_a_strain_for_me_much_of_the_time                                                                      -0.899
## I_have_strange_and_peculiar_thoughts                                                                           1.822
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                       -0.899
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything                      0.635
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to             -0.899
## At_times_I_think_I_am_no_good_at_all                                                                           1.191
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                                 1.293
## I_am_happy_most_of_the_time                                                                                   -0.899
## I_very_seldom_have_spells_of_the_blues                                                                         0.098
## During_the_past_few_years_I_have_been_well_most_of_the_time                                                    2.071
## My_daily_life_is_full_of_things_that_keep_me_interested                                                       -0.899
## I_am_usually_calm_and_not_easily_upset                                                                        -0.899
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                                      -0.899
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                              -0.899
## I_am_liked_by_most_people_who_know_me                                                                         -0.899
## I_am_not_easily_angered                                                                                       -0.899
## I_do_not_mind_meeting_strangers                                                                               -0.899
## I_get_all_the_sympathy_I_should                                                                               -0.899
## Little_interest_or_pleasure_in_doing_things                                                                    1.527
## Feeling_down_depressed_or_hopeless                                                                            -0.899
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                            -0.899
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                       -0.899
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                                  -0.899
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                          0.004
## Feeling_panic_or_being_frightened                                                                              2.039
## Avoiding_situations_that_make_you_anxious                                                                     -0.899
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                                  1.108
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                               2.796
## Thoughts_of_actually_hurting_yourself                                                                         -0.899
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                          -0.899
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking         -0.899
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                                  0.778
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home                  -0.899
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                           -0.899
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                                -0.899
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories                2.622
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                                   -0.899
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                                    -0.899
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                             -0.899
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                                      -0.899
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                              -0.899
## Life_satisfaction                                                                                             -1.417
## Job_satisfaction                                                                                              -0.899
## Social_satisfaction                                                                                           -0.899
## Romantic_satisfaction                                                                                         -0.464
## Mood_higher_means_better_mood                                                                                 -0.899
## Anxiety_levels_higher_means_less_anxious                                                                       3.272
## In_most_ways_my_life_is_close_to_my_ideal                                                                      0.370
## The_conditions_of_my_life_are_excellent                                                                        0.571
## I_am_satisfied_with_my_life                                                                                    0.820
## So_far_I_have_gotten_the_important_things_I_want_in_life                                                      -0.899
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                                    -0.648
## Attention_deficit_hyperactivity_disorder_ADHD                                                                  0.834
## Alcohol_abuse                                                                                                 -0.899
## Non_alcohol_drug_abuse                                                                                        -0.899
## Autism_spectrum_disorder_ASD                                                                                   3.272
## Anti_social_personality_disorder                                                                              -0.899
## Bipolarity                                                                                                    -0.899
## Borderline_Personality_Disorder                                                                               -0.899
## Depression                                                                                                    -0.899
## General_Anxiety_Disorder_GAD                                                                                   2.622
## Obsessive_compulsive_disorder_OCD                                                                             -0.899
## Panic_disorder                                                                                                -0.899
## Paranoia_Paranoid_personality_disorder                                                                        -0.899
## Phobias_social                                                                                                -0.899
## Specific_phobias                                                                                              -0.899
## Post_traumatic_stress_disorder_PTSD                                                                            3.272
## Schizophrenia                                                                                                 -0.899
## Schizoid_personality_disorder                                                                                 -0.899
## Sleeping_disorders                                                                                             3.119
##                                                                                                        max.D
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                                0.117
## Most_of_the_time_I_feel_blue                                                                           0.000
## I_often_feel_as_if_things_were_not_real                                                                0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                       0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                              0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                   0.000
## Life_is_a_strain_for_me_much_of_the_time                                                               0.000
## I_have_strange_and_peculiar_thoughts                                                                   0.308
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                0.000
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything              0.102
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to      0.000
## At_times_I_think_I_am_no_good_at_all                                                                   0.234
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                         0.144
## I_am_happy_most_of_the_time                                                                            0.000
## I_very_seldom_have_spells_of_the_blues                                                                 0.094
## During_the_past_few_years_I_have_been_well_most_of_the_time                                            0.256
## My_daily_life_is_full_of_things_that_keep_me_interested                                                0.000
## I_am_usually_calm_and_not_easily_upset                                                                 0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                               0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                       0.000
## I_am_liked_by_most_people_who_know_me                                                                  0.000
## I_am_not_easily_angered                                                                                0.000
## I_do_not_mind_meeting_strangers                                                                        0.000
## I_get_all_the_sympathy_I_should                                                                        0.000
## Little_interest_or_pleasure_in_doing_things                                                           -0.123
## Feeling_down_depressed_or_hopeless                                                                     0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                     0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                0.000
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                           0.000
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                  0.115
## Feeling_panic_or_being_frightened                                                                     -0.293
## Avoiding_situations_that_make_you_anxious                                                              0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                         -0.278
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                       0.326
## Thoughts_of_actually_hurting_yourself                                                                  0.000
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                   0.000
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking  0.000
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                         -0.316
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home           0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                    0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                         0.000
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories       -0.296
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                            0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                             0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                      0.000
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                               0.000
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                       0.000
## Life_satisfaction                                                                                     -0.225
## Job_satisfaction                                                                                       0.000
## Social_satisfaction                                                                                    0.000
## Romantic_satisfaction                                                                                 -0.428
## Mood_higher_means_better_mood                                                                          0.000
## Anxiety_levels_higher_means_less_anxious                                                               0.680
## In_most_ways_my_life_is_close_to_my_ideal                                                             -0.365
## The_conditions_of_my_life_are_excellent                                                               -0.419
## I_am_satisfied_with_my_life                                                                           -0.425
## So_far_I_have_gotten_the_important_things_I_want_in_life                                               0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                            -0.495
## Attention_deficit_hyperactivity_disorder_ADHD                                                          0.082
## Alcohol_abuse                                                                                          0.000
## Non_alcohol_drug_abuse                                                                                 0.000
## Autism_spectrum_disorder_ASD                                                                           0.257
## Anti_social_personality_disorder                                                                       0.000
## Bipolarity                                                                                             0.000
## Borderline_Personality_Disorder                                                                        0.000
## Depression                                                                                             0.000
## General_Anxiety_Disorder_GAD                                                                           0.230
## Obsessive_compulsive_disorder_OCD                                                                      0.000
## Panic_disorder                                                                                         0.000
## Paranoia_Paranoid_personality_disorder                                                                 0.000
## Phobias_social                                                                                         0.000
## Specific_phobias                                                                                       0.000
## Post_traumatic_stress_disorder_PTSD                                                                    0.395
## Schizophrenia                                                                                          0.000
## Schizoid_personality_disorder                                                                          0.000
## Sleeping_disorders                                                                                    -0.249
##                                                                                                       mean.ES.foc
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                                     0.348
## Most_of_the_time_I_feel_blue                                                                                0.303
## I_often_feel_as_if_things_were_not_real                                                                     0.206
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                            0.303
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                                   0.340
## I_feel_that_I_have_often_been_punished_without_cause                                                        0.286
## Life_is_a_strain_for_me_much_of_the_time                                                                    0.374
## I_have_strange_and_peculiar_thoughts                                                                        0.391
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                     0.285
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything                   0.314
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to           0.211
## At_times_I_think_I_am_no_good_at_all                                                                        0.407
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                              0.414
## I_am_happy_most_of_the_time                                                                                 0.355
## I_very_seldom_have_spells_of_the_blues                                                                      0.528
## During_the_past_few_years_I_have_been_well_most_of_the_time                                                 0.297
## My_daily_life_is_full_of_things_that_keep_me_interested                                                     0.308
## I_am_usually_calm_and_not_easily_upset                                                                      0.231
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                                    0.235
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                            0.446
## I_am_liked_by_most_people_who_know_me                                                                       0.117
## I_am_not_easily_angered                                                                                     0.275
## I_do_not_mind_meeting_strangers                                                                             0.320
## I_get_all_the_sympathy_I_should                                                                             0.298
## Little_interest_or_pleasure_in_doing_things                                                                 1.364
## Feeling_down_depressed_or_hopeless                                                                          1.352
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                          1.249
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                     1.145
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                                0.699
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                       1.434
## Feeling_panic_or_being_frightened                                                                           0.967
## Avoiding_situations_that_make_you_anxious                                                                   1.407
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                               1.057
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                            0.787
## Thoughts_of_actually_hurting_yourself                                                                       0.477
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                        0.286
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking       0.284
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                               1.354
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home                0.756
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                         0.767
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                              0.620
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories             0.750
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                                 0.874
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                                  1.050
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                           0.457
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                                    0.687
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                            0.488
## Life_satisfaction                                                                                           2.386
## Job_satisfaction                                                                                            2.869
## Social_satisfaction                                                                                         2.769
## Romantic_satisfaction                                                                                       2.593
## Mood_higher_means_better_mood                                                                               2.419
## Anxiety_levels_higher_means_less_anxious                                                                    3.050
## In_most_ways_my_life_is_close_to_my_ideal                                                                   2.856
## The_conditions_of_my_life_are_excellent                                                                     2.727
## I_am_satisfied_with_my_life                                                                                 2.569
## So_far_I_have_gotten_the_important_things_I_want_in_life                                                    2.622
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                                  3.315
## Attention_deficit_hyperactivity_disorder_ADHD                                                               0.156
## Alcohol_abuse                                                                                               0.052
## Non_alcohol_drug_abuse                                                                                      0.023
## Autism_spectrum_disorder_ASD                                                                                0.053
## Anti_social_personality_disorder                                                                            0.020
## Bipolarity                                                                                                  0.047
## Borderline_Personality_Disorder                                                                             0.026
## Depression                                                                                                  0.296
## General_Anxiety_Disorder_GAD                                                                                0.276
## Obsessive_compulsive_disorder_OCD                                                                           0.044
## Panic_disorder                                                                                              0.063
## Paranoia_Paranoid_personality_disorder                                                                      0.003
## Phobias_social                                                                                              0.022
## Specific_phobias                                                                                            0.022
## Post_traumatic_stress_disorder_PTSD                                                                         0.086
## Schizophrenia                                                                                               0.002
## Schizoid_personality_disorder                                                                               0.003
## Sleeping_disorders                                                                                          0.081
##                                                                                                       mean.ES.ref
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                                     0.352
## Most_of_the_time_I_feel_blue                                                                                0.303
## I_often_feel_as_if_things_were_not_real                                                                     0.206
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                            0.303
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                                   0.340
## I_feel_that_I_have_often_been_punished_without_cause                                                        0.286
## Life_is_a_strain_for_me_much_of_the_time                                                                    0.374
## I_have_strange_and_peculiar_thoughts                                                                        0.244
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                     0.285
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything                   0.259
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to           0.211
## At_times_I_think_I_am_no_good_at_all                                                                        0.301
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                              0.334
## I_am_happy_most_of_the_time                                                                                 0.355
## I_very_seldom_have_spells_of_the_blues                                                                      0.465
## During_the_past_few_years_I_have_been_well_most_of_the_time                                                 0.248
## My_daily_life_is_full_of_things_that_keep_me_interested                                                     0.308
## I_am_usually_calm_and_not_easily_upset                                                                      0.231
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                                    0.235
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                            0.446
## I_am_liked_by_most_people_who_know_me                                                                       0.117
## I_am_not_easily_angered                                                                                     0.275
## I_do_not_mind_meeting_strangers                                                                             0.320
## I_get_all_the_sympathy_I_should                                                                             0.298
## Little_interest_or_pleasure_in_doing_things                                                                 1.385
## Feeling_down_depressed_or_hopeless                                                                          1.352
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                          1.249
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                     1.145
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                                0.699
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                       1.341
## Feeling_panic_or_being_frightened                                                                           1.000
## Avoiding_situations_that_make_you_anxious                                                                   1.407
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                               1.279
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                            0.892
## Thoughts_of_actually_hurting_yourself                                                                       0.477
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                        0.286
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking       0.284
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                               1.602
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home                0.756
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                         0.767
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                              0.620
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories             0.680
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                                 0.874
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                                  1.050
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                           0.457
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                                    0.687
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                            0.488
## Life_satisfaction                                                                                           2.464
## Job_satisfaction                                                                                            2.869
## Social_satisfaction                                                                                         2.769
## Romantic_satisfaction                                                                                       2.920
## Mood_higher_means_better_mood                                                                               2.419
## Anxiety_levels_higher_means_less_anxious                                                                    2.998
## In_most_ways_my_life_is_close_to_my_ideal                                                                   3.103
## The_conditions_of_my_life_are_excellent                                                                     3.057
## I_am_satisfied_with_my_life                                                                                 2.875
## So_far_I_have_gotten_the_important_things_I_want_in_life                                                    2.622
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                                  3.662
## Attention_deficit_hyperactivity_disorder_ADHD                                                               0.085
## Alcohol_abuse                                                                                               0.052
## Non_alcohol_drug_abuse                                                                                      0.023
## Autism_spectrum_disorder_ASD                                                                                0.012
## Anti_social_personality_disorder                                                                            0.020
## Bipolarity                                                                                                  0.047
## Borderline_Personality_Disorder                                                                             0.026
## Depression                                                                                                  0.296
## General_Anxiety_Disorder_GAD                                                                                0.186
## Obsessive_compulsive_disorder_OCD                                                                           0.044
## Panic_disorder                                                                                              0.063
## Paranoia_Paranoid_personality_disorder                                                                      0.003
## Phobias_social                                                                                              0.022
## Specific_phobias                                                                                            0.022
## Post_traumatic_stress_disorder_PTSD                                                                         0.087
## Schizophrenia                                                                                               0.002
## Schizoid_personality_disorder                                                                               0.003
## Sleeping_disorders                                                                                          0.149
## 
## $conservative
##                                                                                                        SIDS
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               0.000
## Most_of_the_time_I_feel_blue                                                                          0.000
## I_often_feel_as_if_things_were_not_real                                                               0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                      0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                             0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                  0.000
## Life_is_a_strain_for_me_much_of_the_time                                                              0.000
## I_have_strange_and_peculiar_thoughts                                                                  0.150
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up               0.000
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything             0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to     0.000
## At_times_I_think_I_am_no_good_at_all                                                                  0.110
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                        0.000
## I_am_happy_most_of_the_time                                                                           0.000
## I_very_seldom_have_spells_of_the_blues                                                                0.000
## During_the_past_few_years_I_have_been_well_most_of_the_time                                           0.000
## My_daily_life_is_full_of_things_that_keep_me_interested                                               0.000
## I_am_usually_calm_and_not_easily_upset                                                                0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                              0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                      0.000
## I_am_liked_by_most_people_who_know_me                                                                 0.000
## I_am_not_easily_angered                                                                               0.000
## I_do_not_mind_meeting_strangers                                                                       0.000
## I_get_all_the_sympathy_I_should                                                                       0.000
## Little_interest_or_pleasure_in_doing_things                                                           0.000
## Feeling_down_depressed_or_hopeless                                                                    0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                    0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                               0.000
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                          0.000
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 0.000
## Feeling_panic_or_being_frightened                                                                     0.000
## Avoiding_situations_that_make_you_anxious                                                             0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                         0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                      0.000
## Thoughts_of_actually_hurting_yourself                                                                 0.000
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                  0.000
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking 0.000
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                         0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home          0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                   0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                        0.000
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories       0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                           0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                            0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                     0.000
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                              0.000
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                      0.000
## Life_satisfaction                                                                                     0.000
## Job_satisfaction                                                                                      0.000
## Social_satisfaction                                                                                   0.000
## Romantic_satisfaction                                                                                 0.000
## Mood_higher_means_better_mood                                                                         0.000
## Anxiety_levels_higher_means_less_anxious                                                              0.000
## In_most_ways_my_life_is_close_to_my_ideal                                                             0.000
## The_conditions_of_my_life_are_excellent                                                               0.000
## I_am_satisfied_with_my_life                                                                           0.000
## So_far_I_have_gotten_the_important_things_I_want_in_life                                              0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                            0.000
## Attention_deficit_hyperactivity_disorder_ADHD                                                         0.072
## Alcohol_abuse                                                                                         0.000
## Non_alcohol_drug_abuse                                                                                0.000
## Autism_spectrum_disorder_ASD                                                                          0.000
## Anti_social_personality_disorder                                                                      0.000
## Bipolarity                                                                                            0.000
## Borderline_Personality_Disorder                                                                       0.000
## Depression                                                                                            0.000
## General_Anxiety_Disorder_GAD                                                                          0.000
## Obsessive_compulsive_disorder_OCD                                                                     0.000
## Panic_disorder                                                                                        0.000
## Paranoia_Paranoid_personality_disorder                                                                0.000
## Phobias_social                                                                                        0.000
## Specific_phobias                                                                                      0.000
## Post_traumatic_stress_disorder_PTSD                                                                   0.000
## Schizophrenia                                                                                         0.000
## Schizoid_personality_disorder                                                                         0.000
## Sleeping_disorders                                                                                    0.000
##                                                                                                        UIDS
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               0.000
## Most_of_the_time_I_feel_blue                                                                          0.000
## I_often_feel_as_if_things_were_not_real                                                               0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                      0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                             0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                  0.000
## Life_is_a_strain_for_me_much_of_the_time                                                              0.000
## I_have_strange_and_peculiar_thoughts                                                                  0.151
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up               0.000
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything             0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to     0.000
## At_times_I_think_I_am_no_good_at_all                                                                  0.110
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                        0.000
## I_am_happy_most_of_the_time                                                                           0.000
## I_very_seldom_have_spells_of_the_blues                                                                0.000
## During_the_past_few_years_I_have_been_well_most_of_the_time                                           0.000
## My_daily_life_is_full_of_things_that_keep_me_interested                                               0.000
## I_am_usually_calm_and_not_easily_upset                                                                0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                              0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                      0.000
## I_am_liked_by_most_people_who_know_me                                                                 0.000
## I_am_not_easily_angered                                                                               0.000
## I_do_not_mind_meeting_strangers                                                                       0.000
## I_get_all_the_sympathy_I_should                                                                       0.000
## Little_interest_or_pleasure_in_doing_things                                                           0.000
## Feeling_down_depressed_or_hopeless                                                                    0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                    0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                               0.000
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                          0.000
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 0.000
## Feeling_panic_or_being_frightened                                                                     0.000
## Avoiding_situations_that_make_you_anxious                                                             0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                         0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                      0.000
## Thoughts_of_actually_hurting_yourself                                                                 0.000
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                  0.000
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking 0.000
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                         0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home          0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                   0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                        0.000
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories       0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                           0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                            0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                     0.000
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                              0.000
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                      0.000
## Life_satisfaction                                                                                     0.000
## Job_satisfaction                                                                                      0.000
## Social_satisfaction                                                                                   0.000
## Romantic_satisfaction                                                                                 0.000
## Mood_higher_means_better_mood                                                                         0.000
## Anxiety_levels_higher_means_less_anxious                                                              0.000
## In_most_ways_my_life_is_close_to_my_ideal                                                             0.000
## The_conditions_of_my_life_are_excellent                                                               0.000
## I_am_satisfied_with_my_life                                                                           0.000
## So_far_I_have_gotten_the_important_things_I_want_in_life                                              0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                            0.000
## Attention_deficit_hyperactivity_disorder_ADHD                                                         0.072
## Alcohol_abuse                                                                                         0.000
## Non_alcohol_drug_abuse                                                                                0.000
## Autism_spectrum_disorder_ASD                                                                          0.000
## Anti_social_personality_disorder                                                                      0.000
## Bipolarity                                                                                            0.000
## Borderline_Personality_Disorder                                                                       0.000
## Depression                                                                                            0.000
## General_Anxiety_Disorder_GAD                                                                          0.000
## Obsessive_compulsive_disorder_OCD                                                                     0.000
## Panic_disorder                                                                                        0.000
## Paranoia_Paranoid_personality_disorder                                                                0.000
## Phobias_social                                                                                        0.000
## Specific_phobias                                                                                      0.000
## Post_traumatic_stress_disorder_PTSD                                                                   0.000
## Schizophrenia                                                                                         0.000
## Schizoid_personality_disorder                                                                         0.000
## Sleeping_disorders                                                                                    0.000
##                                                                                                        SIDN
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               0.000
## Most_of_the_time_I_feel_blue                                                                          0.000
## I_often_feel_as_if_things_were_not_real                                                               0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                      0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                             0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                  0.000
## Life_is_a_strain_for_me_much_of_the_time                                                              0.000
## I_have_strange_and_peculiar_thoughts                                                                  0.147
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up               0.000
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything             0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to     0.000
## At_times_I_think_I_am_no_good_at_all                                                                  0.108
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                        0.000
## I_am_happy_most_of_the_time                                                                           0.000
## I_very_seldom_have_spells_of_the_blues                                                                0.000
## During_the_past_few_years_I_have_been_well_most_of_the_time                                           0.000
## My_daily_life_is_full_of_things_that_keep_me_interested                                               0.000
## I_am_usually_calm_and_not_easily_upset                                                                0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                              0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                      0.000
## I_am_liked_by_most_people_who_know_me                                                                 0.000
## I_am_not_easily_angered                                                                               0.000
## I_do_not_mind_meeting_strangers                                                                       0.000
## I_get_all_the_sympathy_I_should                                                                       0.000
## Little_interest_or_pleasure_in_doing_things                                                           0.000
## Feeling_down_depressed_or_hopeless                                                                    0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                    0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                               0.000
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                          0.000
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 0.000
## Feeling_panic_or_being_frightened                                                                     0.000
## Avoiding_situations_that_make_you_anxious                                                             0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                         0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                      0.000
## Thoughts_of_actually_hurting_yourself                                                                 0.000
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                  0.000
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking 0.000
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                         0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home          0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                   0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                        0.000
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories       0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                           0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                            0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                     0.000
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                              0.000
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                      0.000
## Life_satisfaction                                                                                     0.000
## Job_satisfaction                                                                                      0.000
## Social_satisfaction                                                                                   0.000
## Romantic_satisfaction                                                                                 0.000
## Mood_higher_means_better_mood                                                                         0.000
## Anxiety_levels_higher_means_less_anxious                                                              0.000
## In_most_ways_my_life_is_close_to_my_ideal                                                             0.000
## The_conditions_of_my_life_are_excellent                                                               0.000
## I_am_satisfied_with_my_life                                                                           0.000
## So_far_I_have_gotten_the_important_things_I_want_in_life                                              0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                            0.000
## Attention_deficit_hyperactivity_disorder_ADHD                                                         0.072
## Alcohol_abuse                                                                                         0.000
## Non_alcohol_drug_abuse                                                                                0.000
## Autism_spectrum_disorder_ASD                                                                          0.000
## Anti_social_personality_disorder                                                                      0.000
## Bipolarity                                                                                            0.000
## Borderline_Personality_Disorder                                                                       0.000
## Depression                                                                                            0.000
## General_Anxiety_Disorder_GAD                                                                          0.000
## Obsessive_compulsive_disorder_OCD                                                                     0.000
## Panic_disorder                                                                                        0.000
## Paranoia_Paranoid_personality_disorder                                                                0.000
## Phobias_social                                                                                        0.000
## Specific_phobias                                                                                      0.000
## Post_traumatic_stress_disorder_PTSD                                                                   0.000
## Schizophrenia                                                                                         0.000
## Schizoid_personality_disorder                                                                         0.000
## Sleeping_disorders                                                                                    0.000
##                                                                                                        UIDN
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               0.000
## Most_of_the_time_I_feel_blue                                                                          0.000
## I_often_feel_as_if_things_were_not_real                                                               0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                      0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                             0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                  0.000
## Life_is_a_strain_for_me_much_of_the_time                                                              0.000
## I_have_strange_and_peculiar_thoughts                                                                  0.148
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up               0.000
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything             0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to     0.000
## At_times_I_think_I_am_no_good_at_all                                                                  0.108
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                        0.000
## I_am_happy_most_of_the_time                                                                           0.000
## I_very_seldom_have_spells_of_the_blues                                                                0.000
## During_the_past_few_years_I_have_been_well_most_of_the_time                                           0.000
## My_daily_life_is_full_of_things_that_keep_me_interested                                               0.000
## I_am_usually_calm_and_not_easily_upset                                                                0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                              0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                      0.000
## I_am_liked_by_most_people_who_know_me                                                                 0.000
## I_am_not_easily_angered                                                                               0.000
## I_do_not_mind_meeting_strangers                                                                       0.000
## I_get_all_the_sympathy_I_should                                                                       0.000
## Little_interest_or_pleasure_in_doing_things                                                           0.000
## Feeling_down_depressed_or_hopeless                                                                    0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                    0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                               0.000
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                          0.000
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 0.000
## Feeling_panic_or_being_frightened                                                                     0.000
## Avoiding_situations_that_make_you_anxious                                                             0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                         0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                      0.000
## Thoughts_of_actually_hurting_yourself                                                                 0.000
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                  0.000
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking 0.000
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                         0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home          0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                   0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                        0.000
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories       0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                           0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                            0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                     0.000
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                              0.000
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                      0.000
## Life_satisfaction                                                                                     0.000
## Job_satisfaction                                                                                      0.000
## Social_satisfaction                                                                                   0.000
## Romantic_satisfaction                                                                                 0.000
## Mood_higher_means_better_mood                                                                         0.000
## Anxiety_levels_higher_means_less_anxious                                                              0.000
## In_most_ways_my_life_is_close_to_my_ideal                                                             0.000
## The_conditions_of_my_life_are_excellent                                                               0.000
## I_am_satisfied_with_my_life                                                                           0.000
## So_far_I_have_gotten_the_important_things_I_want_in_life                                              0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                            0.000
## Attention_deficit_hyperactivity_disorder_ADHD                                                         0.073
## Alcohol_abuse                                                                                         0.000
## Non_alcohol_drug_abuse                                                                                0.000
## Autism_spectrum_disorder_ASD                                                                          0.000
## Anti_social_personality_disorder                                                                      0.000
## Bipolarity                                                                                            0.000
## Borderline_Personality_Disorder                                                                       0.000
## Depression                                                                                            0.000
## General_Anxiety_Disorder_GAD                                                                          0.000
## Obsessive_compulsive_disorder_OCD                                                                     0.000
## Panic_disorder                                                                                        0.000
## Paranoia_Paranoid_personality_disorder                                                                0.000
## Phobias_social                                                                                        0.000
## Specific_phobias                                                                                      0.000
## Post_traumatic_stress_disorder_PTSD                                                                   0.000
## Schizophrenia                                                                                         0.000
## Schizoid_personality_disorder                                                                         0.000
## Sleeping_disorders                                                                                    0.000
##                                                                                                        ESSD
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               0.000
## Most_of_the_time_I_feel_blue                                                                          0.000
## I_often_feel_as_if_things_were_not_real                                                               0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                      0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                             0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                  0.000
## Life_is_a_strain_for_me_much_of_the_time                                                              0.000
## I_have_strange_and_peculiar_thoughts                                                                  0.698
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up               0.000
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything             0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to     0.000
## At_times_I_think_I_am_no_good_at_all                                                                  0.357
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                        0.000
## I_am_happy_most_of_the_time                                                                           0.000
## I_very_seldom_have_spells_of_the_blues                                                                0.000
## During_the_past_few_years_I_have_been_well_most_of_the_time                                           0.000
## My_daily_life_is_full_of_things_that_keep_me_interested                                               0.000
## I_am_usually_calm_and_not_easily_upset                                                                0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                              0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                      0.000
## I_am_liked_by_most_people_who_know_me                                                                 0.000
## I_am_not_easily_angered                                                                               0.000
## I_do_not_mind_meeting_strangers                                                                       0.000
## I_get_all_the_sympathy_I_should                                                                       0.000
## Little_interest_or_pleasure_in_doing_things                                                           0.000
## Feeling_down_depressed_or_hopeless                                                                    0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                    0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                               0.000
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                          0.000
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 0.000
## Feeling_panic_or_being_frightened                                                                     0.000
## Avoiding_situations_that_make_you_anxious                                                             0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                         0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                      0.000
## Thoughts_of_actually_hurting_yourself                                                                 0.000
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                  0.000
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking 0.000
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                         0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home          0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                   0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                        0.000
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories       0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                           0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                            0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                     0.000
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                              0.000
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                      0.000
## Life_satisfaction                                                                                     0.000
## Job_satisfaction                                                                                      0.000
## Social_satisfaction                                                                                   0.000
## Romantic_satisfaction                                                                                 0.000
## Mood_higher_means_better_mood                                                                         0.000
## Anxiety_levels_higher_means_less_anxious                                                              0.000
## In_most_ways_my_life_is_close_to_my_ideal                                                             0.000
## The_conditions_of_my_life_are_excellent                                                               0.000
## I_am_satisfied_with_my_life                                                                           0.000
## So_far_I_have_gotten_the_important_things_I_want_in_life                                              0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                            0.000
## Attention_deficit_hyperactivity_disorder_ADHD                                                         1.091
## Alcohol_abuse                                                                                         0.000
## Non_alcohol_drug_abuse                                                                                0.000
## Autism_spectrum_disorder_ASD                                                                          0.000
## Anti_social_personality_disorder                                                                      0.000
## Bipolarity                                                                                            0.000
## Borderline_Personality_Disorder                                                                       0.000
## Depression                                                                                            0.000
## General_Anxiety_Disorder_GAD                                                                          0.000
## Obsessive_compulsive_disorder_OCD                                                                     0.000
## Panic_disorder                                                                                        0.000
## Paranoia_Paranoid_personality_disorder                                                                0.000
## Phobias_social                                                                                        0.000
## Specific_phobias                                                                                      0.000
## Post_traumatic_stress_disorder_PTSD                                                                   0.000
## Schizophrenia                                                                                         0.000
## Schizoid_personality_disorder                                                                         0.000
## Sleeping_disorders                                                                                    0.000
##                                                                                                       theta.of.max.D
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                                       -0.997
## Most_of_the_time_I_feel_blue                                                                                  -0.997
## I_often_feel_as_if_things_were_not_real                                                                       -0.997
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                              -0.997
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                                     -0.997
## I_feel_that_I_have_often_been_punished_without_cause                                                          -0.997
## Life_is_a_strain_for_me_much_of_the_time                                                                      -0.997
## I_have_strange_and_peculiar_thoughts                                                                           1.808
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                       -0.997
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything                     -0.997
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to             -0.997
## At_times_I_think_I_am_no_good_at_all                                                                           1.170
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                                -0.997
## I_am_happy_most_of_the_time                                                                                   -0.997
## I_very_seldom_have_spells_of_the_blues                                                                        -0.997
## During_the_past_few_years_I_have_been_well_most_of_the_time                                                   -0.997
## My_daily_life_is_full_of_things_that_keep_me_interested                                                       -0.997
## I_am_usually_calm_and_not_easily_upset                                                                        -0.997
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                                      -0.997
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                              -0.997
## I_am_liked_by_most_people_who_know_me                                                                         -0.997
## I_am_not_easily_angered                                                                                       -0.997
## I_do_not_mind_meeting_strangers                                                                               -0.997
## I_get_all_the_sympathy_I_should                                                                               -0.997
## Little_interest_or_pleasure_in_doing_things                                                                   -0.997
## Feeling_down_depressed_or_hopeless                                                                            -0.997
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                            -0.997
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                       -0.997
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                                  -0.997
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                         -0.997
## Feeling_panic_or_being_frightened                                                                             -0.997
## Avoiding_situations_that_make_you_anxious                                                                     -0.997
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                                 -0.997
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                              -0.997
## Thoughts_of_actually_hurting_yourself                                                                         -0.997
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                          -0.997
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking         -0.997
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                                 -0.997
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home                  -0.997
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                           -0.997
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                                -0.997
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories               -0.997
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                                   -0.997
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                                    -0.997
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                             -0.997
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                                      -0.997
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                              -0.997
## Life_satisfaction                                                                                             -0.997
## Job_satisfaction                                                                                              -0.997
## Social_satisfaction                                                                                           -0.997
## Romantic_satisfaction                                                                                         -0.997
## Mood_higher_means_better_mood                                                                                 -0.997
## Anxiety_levels_higher_means_less_anxious                                                                      -0.997
## In_most_ways_my_life_is_close_to_my_ideal                                                                     -0.997
## The_conditions_of_my_life_are_excellent                                                                       -0.997
## I_am_satisfied_with_my_life                                                                                   -0.997
## So_far_I_have_gotten_the_important_things_I_want_in_life                                                      -0.997
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                                    -0.997
## Attention_deficit_hyperactivity_disorder_ADHD                                                                  0.770
## Alcohol_abuse                                                                                                 -0.997
## Non_alcohol_drug_abuse                                                                                        -0.997
## Autism_spectrum_disorder_ASD                                                                                  -0.997
## Anti_social_personality_disorder                                                                              -0.997
## Bipolarity                                                                                                    -0.997
## Borderline_Personality_Disorder                                                                               -0.997
## Depression                                                                                                    -0.997
## General_Anxiety_Disorder_GAD                                                                                  -0.997
## Obsessive_compulsive_disorder_OCD                                                                             -0.997
## Panic_disorder                                                                                                -0.997
## Paranoia_Paranoid_personality_disorder                                                                        -0.997
## Phobias_social                                                                                                -0.997
## Specific_phobias                                                                                              -0.997
## Post_traumatic_stress_disorder_PTSD                                                                           -0.997
## Schizophrenia                                                                                                 -0.997
## Schizoid_personality_disorder                                                                                 -0.997
## Sleeping_disorders                                                                                            -0.997
##                                                                                                       max.D
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               0.000
## Most_of_the_time_I_feel_blue                                                                          0.000
## I_often_feel_as_if_things_were_not_real                                                               0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                      0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                             0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                  0.000
## Life_is_a_strain_for_me_much_of_the_time                                                              0.000
## I_have_strange_and_peculiar_thoughts                                                                  0.309
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up               0.000
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything             0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to     0.000
## At_times_I_think_I_am_no_good_at_all                                                                  0.238
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                        0.000
## I_am_happy_most_of_the_time                                                                           0.000
## I_very_seldom_have_spells_of_the_blues                                                                0.000
## During_the_past_few_years_I_have_been_well_most_of_the_time                                           0.000
## My_daily_life_is_full_of_things_that_keep_me_interested                                               0.000
## I_am_usually_calm_and_not_easily_upset                                                                0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                              0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                      0.000
## I_am_liked_by_most_people_who_know_me                                                                 0.000
## I_am_not_easily_angered                                                                               0.000
## I_do_not_mind_meeting_strangers                                                                       0.000
## I_get_all_the_sympathy_I_should                                                                       0.000
## Little_interest_or_pleasure_in_doing_things                                                           0.000
## Feeling_down_depressed_or_hopeless                                                                    0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                    0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                               0.000
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                          0.000
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 0.000
## Feeling_panic_or_being_frightened                                                                     0.000
## Avoiding_situations_that_make_you_anxious                                                             0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                         0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                      0.000
## Thoughts_of_actually_hurting_yourself                                                                 0.000
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                  0.000
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking 0.000
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                         0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home          0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                   0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                        0.000
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories       0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                           0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                            0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                     0.000
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                              0.000
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                      0.000
## Life_satisfaction                                                                                     0.000
## Job_satisfaction                                                                                      0.000
## Social_satisfaction                                                                                   0.000
## Romantic_satisfaction                                                                                 0.000
## Mood_higher_means_better_mood                                                                         0.000
## Anxiety_levels_higher_means_less_anxious                                                              0.000
## In_most_ways_my_life_is_close_to_my_ideal                                                             0.000
## The_conditions_of_my_life_are_excellent                                                               0.000
## I_am_satisfied_with_my_life                                                                           0.000
## So_far_I_have_gotten_the_important_things_I_want_in_life                                              0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                            0.000
## Attention_deficit_hyperactivity_disorder_ADHD                                                         0.083
## Alcohol_abuse                                                                                         0.000
## Non_alcohol_drug_abuse                                                                                0.000
## Autism_spectrum_disorder_ASD                                                                          0.000
## Anti_social_personality_disorder                                                                      0.000
## Bipolarity                                                                                            0.000
## Borderline_Personality_Disorder                                                                       0.000
## Depression                                                                                            0.000
## General_Anxiety_Disorder_GAD                                                                          0.000
## Obsessive_compulsive_disorder_OCD                                                                     0.000
## Panic_disorder                                                                                        0.000
## Paranoia_Paranoid_personality_disorder                                                                0.000
## Phobias_social                                                                                        0.000
## Specific_phobias                                                                                      0.000
## Post_traumatic_stress_disorder_PTSD                                                                   0.000
## Schizophrenia                                                                                         0.000
## Schizoid_personality_disorder                                                                         0.000
## Sleeping_disorders                                                                                    0.000
##                                                                                                       mean.ES.foc
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                                     0.354
## Most_of_the_time_I_feel_blue                                                                                0.302
## I_often_feel_as_if_things_were_not_real                                                                     0.205
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                            0.301
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                                   0.338
## I_feel_that_I_have_often_been_punished_without_cause                                                        0.285
## Life_is_a_strain_for_me_much_of_the_time                                                                    0.372
## I_have_strange_and_peculiar_thoughts                                                                        0.391
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                     0.284
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything                   0.285
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to           0.210
## At_times_I_think_I_am_no_good_at_all                                                                        0.407
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                              0.378
## I_am_happy_most_of_the_time                                                                                 0.353
## I_very_seldom_have_spells_of_the_blues                                                                      0.493
## During_the_past_few_years_I_have_been_well_most_of_the_time                                                 0.284
## My_daily_life_is_full_of_things_that_keep_me_interested                                                     0.306
## I_am_usually_calm_and_not_easily_upset                                                                      0.230
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                                    0.233
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                            0.443
## I_am_liked_by_most_people_who_know_me                                                                       0.117
## I_am_not_easily_angered                                                                                     0.274
## I_do_not_mind_meeting_strangers                                                                             0.318
## I_get_all_the_sympathy_I_should                                                                             0.296
## Little_interest_or_pleasure_in_doing_things                                                                 1.358
## Feeling_down_depressed_or_hopeless                                                                          1.342
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                          1.241
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                     1.139
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                                0.696
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                       1.382
## Feeling_panic_or_being_frightened                                                                           0.964
## Avoiding_situations_that_make_you_anxious                                                                   1.398
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                               1.147
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                            0.840
## Thoughts_of_actually_hurting_yourself                                                                       0.475
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                        0.285
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking       0.282
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                               1.458
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home                0.752
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                         0.763
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                              0.616
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories             0.704
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                                 0.869
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                                  1.044
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                           0.455
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                                    0.684
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                            0.486
## Life_satisfaction                                                                                           2.405
## Job_satisfaction                                                                                            2.854
## Social_satisfaction                                                                                         2.753
## Romantic_satisfaction                                                                                       2.746
## Mood_higher_means_better_mood                                                                               2.404
## Anxiety_levels_higher_means_less_anxious                                                                    3.039
## In_most_ways_my_life_is_close_to_my_ideal                                                                   2.965
## The_conditions_of_my_life_are_excellent                                                                     2.868
## I_am_satisfied_with_my_life                                                                                 2.692
## So_far_I_have_gotten_the_important_things_I_want_in_life                                                    2.606
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                                  3.468
## Attention_deficit_hyperactivity_disorder_ADHD                                                               0.156
## Alcohol_abuse                                                                                               0.052
## Non_alcohol_drug_abuse                                                                                      0.023
## Autism_spectrum_disorder_ASD                                                                                0.037
## Anti_social_personality_disorder                                                                            0.020
## Bipolarity                                                                                                  0.047
## Borderline_Personality_Disorder                                                                             0.026
## Depression                                                                                                  0.294
## General_Anxiety_Disorder_GAD                                                                                0.239
## Obsessive_compulsive_disorder_OCD                                                                           0.044
## Panic_disorder                                                                                              0.063
## Paranoia_Paranoid_personality_disorder                                                                      0.003
## Phobias_social                                                                                              0.022
## Specific_phobias                                                                                            0.021
## Post_traumatic_stress_disorder_PTSD                                                                         0.092
## Schizophrenia                                                                                               0.002
## Schizoid_personality_disorder                                                                               0.003
## Sleeping_disorders                                                                                          0.106
##                                                                                                       mean.ES.ref
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                                     0.354
## Most_of_the_time_I_feel_blue                                                                                0.302
## I_often_feel_as_if_things_were_not_real                                                                     0.205
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                            0.301
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                                   0.338
## I_feel_that_I_have_often_been_punished_without_cause                                                        0.285
## Life_is_a_strain_for_me_much_of_the_time                                                                    0.372
## I_have_strange_and_peculiar_thoughts                                                                        0.241
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                     0.284
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything                   0.285
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to           0.210
## At_times_I_think_I_am_no_good_at_all                                                                        0.297
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                              0.378
## I_am_happy_most_of_the_time                                                                                 0.353
## I_very_seldom_have_spells_of_the_blues                                                                      0.493
## During_the_past_few_years_I_have_been_well_most_of_the_time                                                 0.284
## My_daily_life_is_full_of_things_that_keep_me_interested                                                     0.306
## I_am_usually_calm_and_not_easily_upset                                                                      0.230
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                                    0.233
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                            0.443
## I_am_liked_by_most_people_who_know_me                                                                       0.117
## I_am_not_easily_angered                                                                                     0.274
## I_do_not_mind_meeting_strangers                                                                             0.318
## I_get_all_the_sympathy_I_should                                                                             0.296
## Little_interest_or_pleasure_in_doing_things                                                                 1.358
## Feeling_down_depressed_or_hopeless                                                                          1.342
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                          1.241
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                     1.139
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                                0.696
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                       1.382
## Feeling_panic_or_being_frightened                                                                           0.964
## Avoiding_situations_that_make_you_anxious                                                                   1.398
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                               1.147
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                            0.840
## Thoughts_of_actually_hurting_yourself                                                                       0.475
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                        0.285
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking       0.282
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                               1.458
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home                0.752
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                         0.763
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                              0.616
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories             0.704
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                                 0.869
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                                  1.044
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                           0.455
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                                    0.684
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                            0.486
## Life_satisfaction                                                                                           2.405
## Job_satisfaction                                                                                            2.854
## Social_satisfaction                                                                                         2.753
## Romantic_satisfaction                                                                                       2.746
## Mood_higher_means_better_mood                                                                               2.404
## Anxiety_levels_higher_means_less_anxious                                                                    3.039
## In_most_ways_my_life_is_close_to_my_ideal                                                                   2.965
## The_conditions_of_my_life_are_excellent                                                                     2.868
## I_am_satisfied_with_my_life                                                                                 2.692
## So_far_I_have_gotten_the_important_things_I_want_in_life                                                    2.606
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                                  3.468
## Attention_deficit_hyperactivity_disorder_ADHD                                                               0.085
## Alcohol_abuse                                                                                               0.052
## Non_alcohol_drug_abuse                                                                                      0.023
## Autism_spectrum_disorder_ASD                                                                                0.037
## Anti_social_personality_disorder                                                                            0.020
## Bipolarity                                                                                                  0.047
## Borderline_Personality_Disorder                                                                             0.026
## Depression                                                                                                  0.294
## General_Anxiety_Disorder_GAD                                                                                0.239
## Obsessive_compulsive_disorder_OCD                                                                           0.044
## Panic_disorder                                                                                              0.063
## Paranoia_Paranoid_personality_disorder                                                                      0.003
## Phobias_social                                                                                              0.022
## Specific_phobias                                                                                            0.021
## Post_traumatic_stress_disorder_PTSD                                                                         0.092
## Schizophrenia                                                                                               0.002
## Schizoid_personality_disorder                                                                               0.003
## Sleeping_disorders                                                                                          0.106
#plot item functions
plot(
  dif_irt_mh_all_age$fits$anchor_liberal, 
  type = "trace", 
  which.items = dif_irt_mh_all_age$DIF_stats%>% mutate(idx = row_number()) %>% filter(p_adj < 0.05)  %>% pull(idx)
  )

Sex
#DIF with all items
dif_irt_mh_all_sex = DIF_test(
  items = mh_vars_num,
  model = 1,
  itemtype = mh_vars_options$itemtype,
  group = d$sex,
  verbose = F
)
## There are 8 steps
## Step 1: Initial joint fit
## 
## Step 2: Initial MI fit
## 
## Step 3: Leave one out MI testing
## 
## Step 4: Fit without DIF items, liberal threshold
## 
## Step 5: Fit without DIF items, conservative threshold
## 
## Step 6: Fit with anchor items, liberal threshold
## 
## Step 7: Fit with anchor items, conservative threshold
## 
## Step 8: Get scores
#scale level gap and bias
SMD_matrix(d$p_all, d$sex)
##        Female   Male
## Female     NA 0.0733
## Male   0.0733     NA
dif_irt_mh_all_sex$effect_size_test
## $liberal
##           Effect Size  Value
## 1                STDS 1.6846
## 2                UTDS 2.9426
## 3              UETSDS 1.6846
## 4               ETSSD 0.0537
## 5         Starks.DTFR 1.7720
## 6               UDTFR 2.9918
## 7              UETSDN 1.7720
## 8 theta.of.max.test.D 2.6836
## 9           Test.Dmax 8.8317
## 
## $conservative
##           Effect Size  Value
## 1                STDS 0.9234
## 2                UTDS 1.4861
## 3              UETSDS 0.9439
## 4               ETSSD 0.0294
## 5         Starks.DTFR 0.9851
## 6               UDTFR 1.5335
## 7              UETSDN 1.0064
## 8 theta.of.max.test.D 2.7284
## 9           Test.Dmax 6.0703
#plot scale function
plot(
  dif_irt_mh_all_sex$fits$anchor_liberal,
  type = "score"
)

#what items are biased?
dif_irt_mh_all_sex$effect_size_items
## $liberal
##                                                                                                         SIDS
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               -0.049
## Most_of_the_time_I_feel_blue                                                                           0.000
## I_often_feel_as_if_things_were_not_real                                                                0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                      -0.069
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                              0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                   0.000
## Life_is_a_strain_for_me_much_of_the_time                                                               0.000
## I_have_strange_and_peculiar_thoughts                                                                   0.067
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                0.000
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything              0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to      0.000
## At_times_I_think_I_am_no_good_at_all                                                                   0.000
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                         0.000
## I_am_happy_most_of_the_time                                                                            0.000
## I_very_seldom_have_spells_of_the_blues                                                                 0.000
## During_the_past_few_years_I_have_been_well_most_of_the_time                                            0.000
## My_daily_life_is_full_of_things_that_keep_me_interested                                                0.000
## I_am_usually_calm_and_not_easily_upset                                                                -0.070
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                               0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                      -0.095
## I_am_liked_by_most_people_who_know_me                                                                  0.000
## I_am_not_easily_angered                                                                                0.000
## I_do_not_mind_meeting_strangers                                                                        0.000
## I_get_all_the_sympathy_I_should                                                                        0.000
## Little_interest_or_pleasure_in_doing_things                                                            0.000
## Feeling_down_depressed_or_hopeless                                                                     0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                     0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                0.157
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                           0.220
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 -0.170
## Feeling_panic_or_being_frightened                                                                      0.000
## Avoiding_situations_that_make_you_anxious                                                              0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                          0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                       0.000
## Thoughts_of_actually_hurting_yourself                                                                  0.179
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                   0.206
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking  0.223
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                          0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home           0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                    0.121
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                         0.222
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories        0.138
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                            0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                             0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                      0.334
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                               0.178
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                       0.202
## Life_satisfaction                                                                                      0.000
## Job_satisfaction                                                                                      -0.008
## Social_satisfaction                                                                                    0.000
## Romantic_satisfaction                                                                                  0.000
## Mood_higher_means_better_mood                                                                          0.000
## Anxiety_levels_higher_means_less_anxious                                                               0.000
## In_most_ways_my_life_is_close_to_my_ideal                                                              0.000
## The_conditions_of_my_life_are_excellent                                                                0.000
## I_am_satisfied_with_my_life                                                                            0.000
## So_far_I_have_gotten_the_important_things_I_want_in_life                                               0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                             0.000
## Attention_deficit_hyperactivity_disorder_ADHD                                                          0.000
## Alcohol_abuse                                                                                          0.050
## Non_alcohol_drug_abuse                                                                                 0.000
## Autism_spectrum_disorder_ASD                                                                           0.000
## Anti_social_personality_disorder                                                                       0.000
## Bipolarity                                                                                             0.000
## Borderline_Personality_Disorder                                                                        0.000
## Depression                                                                                             0.000
## General_Anxiety_Disorder_GAD                                                                          -0.103
## Obsessive_compulsive_disorder_OCD                                                                      0.000
## Panic_disorder                                                                                         0.000
## Paranoia_Paranoid_personality_disorder                                                                 0.000
## Phobias_social                                                                                         0.000
## Specific_phobias                                                                                       0.000
## Post_traumatic_stress_disorder_PTSD                                                                   -0.047
## Schizophrenia                                                                                          0.000
## Schizoid_personality_disorder                                                                          0.000
## Sleeping_disorders                                                                                     0.000
##                                                                                                        UIDS
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               0.050
## Most_of_the_time_I_feel_blue                                                                          0.000
## I_often_feel_as_if_things_were_not_real                                                               0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                      0.069
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                             0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                  0.000
## Life_is_a_strain_for_me_much_of_the_time                                                              0.000
## I_have_strange_and_peculiar_thoughts                                                                  0.067
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up               0.000
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything             0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to     0.000
## At_times_I_think_I_am_no_good_at_all                                                                  0.000
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                        0.000
## I_am_happy_most_of_the_time                                                                           0.000
## I_very_seldom_have_spells_of_the_blues                                                                0.000
## During_the_past_few_years_I_have_been_well_most_of_the_time                                           0.000
## My_daily_life_is_full_of_things_that_keep_me_interested                                               0.000
## I_am_usually_calm_and_not_easily_upset                                                                0.070
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                              0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                      0.095
## I_am_liked_by_most_people_who_know_me                                                                 0.000
## I_am_not_easily_angered                                                                               0.000
## I_do_not_mind_meeting_strangers                                                                       0.000
## I_get_all_the_sympathy_I_should                                                                       0.000
## Little_interest_or_pleasure_in_doing_things                                                           0.000
## Feeling_down_depressed_or_hopeless                                                                    0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                    0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                               0.170
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                          0.220
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 0.171
## Feeling_panic_or_being_frightened                                                                     0.000
## Avoiding_situations_that_make_you_anxious                                                             0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                         0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                      0.000
## Thoughts_of_actually_hurting_yourself                                                                 0.180
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                  0.206
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking 0.224
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                         0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home          0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                   0.121
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                        0.226
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories       0.141
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                           0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                            0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                     0.334
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                              0.178
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                      0.202
## Life_satisfaction                                                                                     0.000
## Job_satisfaction                                                                                      0.018
## Social_satisfaction                                                                                   0.000
## Romantic_satisfaction                                                                                 0.000
## Mood_higher_means_better_mood                                                                         0.000
## Anxiety_levels_higher_means_less_anxious                                                              0.000
## In_most_ways_my_life_is_close_to_my_ideal                                                             0.000
## The_conditions_of_my_life_are_excellent                                                               0.000
## I_am_satisfied_with_my_life                                                                           0.000
## So_far_I_have_gotten_the_important_things_I_want_in_life                                              0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                            0.000
## Attention_deficit_hyperactivity_disorder_ADHD                                                         0.000
## Alcohol_abuse                                                                                         0.050
## Non_alcohol_drug_abuse                                                                                0.000
## Autism_spectrum_disorder_ASD                                                                          0.000
## Anti_social_personality_disorder                                                                      0.000
## Bipolarity                                                                                            0.000
## Borderline_Personality_Disorder                                                                       0.000
## Depression                                                                                            0.000
## General_Anxiety_Disorder_GAD                                                                          0.103
## Obsessive_compulsive_disorder_OCD                                                                     0.000
## Panic_disorder                                                                                        0.000
## Paranoia_Paranoid_personality_disorder                                                                0.000
## Phobias_social                                                                                        0.000
## Specific_phobias                                                                                      0.000
## Post_traumatic_stress_disorder_PTSD                                                                   0.050
## Schizophrenia                                                                                         0.000
## Schizoid_personality_disorder                                                                         0.000
## Sleeping_disorders                                                                                    0.000
##                                                                                                         SIDN
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               -0.046
## Most_of_the_time_I_feel_blue                                                                           0.000
## I_often_feel_as_if_things_were_not_real                                                                0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                      -0.065
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                              0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                   0.000
## Life_is_a_strain_for_me_much_of_the_time                                                               0.000
## I_have_strange_and_peculiar_thoughts                                                                   0.065
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                0.000
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything              0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to      0.000
## At_times_I_think_I_am_no_good_at_all                                                                   0.000
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                         0.000
## I_am_happy_most_of_the_time                                                                            0.000
## I_very_seldom_have_spells_of_the_blues                                                                 0.000
## During_the_past_few_years_I_have_been_well_most_of_the_time                                            0.000
## My_daily_life_is_full_of_things_that_keep_me_interested                                                0.000
## I_am_usually_calm_and_not_easily_upset                                                                -0.070
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                               0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                      -0.092
## I_am_liked_by_most_people_who_know_me                                                                  0.000
## I_am_not_easily_angered                                                                                0.000
## I_do_not_mind_meeting_strangers                                                                        0.000
## I_get_all_the_sympathy_I_should                                                                        0.000
## Little_interest_or_pleasure_in_doing_things                                                            0.000
## Feeling_down_depressed_or_hopeless                                                                     0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                     0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                0.157
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                           0.220
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 -0.165
## Feeling_panic_or_being_frightened                                                                      0.000
## Avoiding_situations_that_make_you_anxious                                                              0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                          0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                       0.000
## Thoughts_of_actually_hurting_yourself                                                                  0.191
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                   0.223
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking  0.239
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                          0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home           0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                    0.118
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                         0.231
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories        0.142
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                            0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                             0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                      0.339
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                               0.178
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                       0.204
## Life_satisfaction                                                                                      0.000
## Job_satisfaction                                                                                      -0.008
## Social_satisfaction                                                                                    0.000
## Romantic_satisfaction                                                                                  0.000
## Mood_higher_means_better_mood                                                                          0.000
## Anxiety_levels_higher_means_less_anxious                                                               0.000
## In_most_ways_my_life_is_close_to_my_ideal                                                              0.000
## The_conditions_of_my_life_are_excellent                                                                0.000
## I_am_satisfied_with_my_life                                                                            0.000
## So_far_I_have_gotten_the_important_things_I_want_in_life                                               0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                             0.000
## Attention_deficit_hyperactivity_disorder_ADHD                                                          0.000
## Alcohol_abuse                                                                                          0.052
## Non_alcohol_drug_abuse                                                                                 0.000
## Autism_spectrum_disorder_ASD                                                                           0.000
## Anti_social_personality_disorder                                                                       0.000
## Bipolarity                                                                                             0.000
## Borderline_Personality_Disorder                                                                        0.000
## Depression                                                                                             0.000
## General_Anxiety_Disorder_GAD                                                                          -0.100
## Obsessive_compulsive_disorder_OCD                                                                      0.000
## Panic_disorder                                                                                         0.000
## Paranoia_Paranoid_personality_disorder                                                                 0.000
## Phobias_social                                                                                         0.000
## Specific_phobias                                                                                       0.000
## Post_traumatic_stress_disorder_PTSD                                                                   -0.044
## Schizophrenia                                                                                          0.000
## Schizoid_personality_disorder                                                                          0.000
## Sleeping_disorders                                                                                     0.000
##                                                                                                        UIDN
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               0.047
## Most_of_the_time_I_feel_blue                                                                          0.000
## I_often_feel_as_if_things_were_not_real                                                               0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                      0.065
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                             0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                  0.000
## Life_is_a_strain_for_me_much_of_the_time                                                              0.000
## I_have_strange_and_peculiar_thoughts                                                                  0.065
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up               0.000
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything             0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to     0.000
## At_times_I_think_I_am_no_good_at_all                                                                  0.000
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                        0.000
## I_am_happy_most_of_the_time                                                                           0.000
## I_very_seldom_have_spells_of_the_blues                                                                0.000
## During_the_past_few_years_I_have_been_well_most_of_the_time                                           0.000
## My_daily_life_is_full_of_things_that_keep_me_interested                                               0.000
## I_am_usually_calm_and_not_easily_upset                                                                0.070
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                              0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                      0.092
## I_am_liked_by_most_people_who_know_me                                                                 0.000
## I_am_not_easily_angered                                                                               0.000
## I_do_not_mind_meeting_strangers                                                                       0.000
## I_get_all_the_sympathy_I_should                                                                       0.000
## Little_interest_or_pleasure_in_doing_things                                                           0.000
## Feeling_down_depressed_or_hopeless                                                                    0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                    0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                               0.173
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                          0.220
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 0.165
## Feeling_panic_or_being_frightened                                                                     0.000
## Avoiding_situations_that_make_you_anxious                                                             0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                         0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                      0.000
## Thoughts_of_actually_hurting_yourself                                                                 0.192
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                  0.224
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking 0.239
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                         0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home          0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                   0.118
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                        0.236
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories       0.145
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                           0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                            0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                     0.339
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                              0.178
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                      0.204
## Life_satisfaction                                                                                     0.000
## Job_satisfaction                                                                                      0.019
## Social_satisfaction                                                                                   0.000
## Romantic_satisfaction                                                                                 0.000
## Mood_higher_means_better_mood                                                                         0.000
## Anxiety_levels_higher_means_less_anxious                                                              0.000
## In_most_ways_my_life_is_close_to_my_ideal                                                             0.000
## The_conditions_of_my_life_are_excellent                                                               0.000
## I_am_satisfied_with_my_life                                                                           0.000
## So_far_I_have_gotten_the_important_things_I_want_in_life                                              0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                            0.000
## Attention_deficit_hyperactivity_disorder_ADHD                                                         0.000
## Alcohol_abuse                                                                                         0.052
## Non_alcohol_drug_abuse                                                                                0.000
## Autism_spectrum_disorder_ASD                                                                          0.000
## Anti_social_personality_disorder                                                                      0.000
## Bipolarity                                                                                            0.000
## Borderline_Personality_Disorder                                                                       0.000
## Depression                                                                                            0.000
## General_Anxiety_Disorder_GAD                                                                          0.100
## Obsessive_compulsive_disorder_OCD                                                                     0.000
## Panic_disorder                                                                                        0.000
## Paranoia_Paranoid_personality_disorder                                                                0.000
## Phobias_social                                                                                        0.000
## Specific_phobias                                                                                      0.000
## Post_traumatic_stress_disorder_PTSD                                                                   0.048
## Schizophrenia                                                                                         0.000
## Schizoid_personality_disorder                                                                         0.000
## Sleeping_disorders                                                                                    0.000
##                                                                                                         ESSD
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               -0.175
## Most_of_the_time_I_feel_blue                                                                           0.000
## I_often_feel_as_if_things_were_not_real                                                                0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                      -0.262
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                              0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                   0.000
## Life_is_a_strain_for_me_much_of_the_time                                                               0.000
## I_have_strange_and_peculiar_thoughts                                                                   0.322
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                0.000
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything              0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to      0.000
## At_times_I_think_I_am_no_good_at_all                                                                   0.000
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                         0.000
## I_am_happy_most_of_the_time                                                                            0.000
## I_very_seldom_have_spells_of_the_blues                                                                 0.000
## During_the_past_few_years_I_have_been_well_most_of_the_time                                            0.000
## My_daily_life_is_full_of_things_that_keep_me_interested                                                0.000
## I_am_usually_calm_and_not_easily_upset                                                                -0.399
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                               0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                      -0.401
## I_am_liked_by_most_people_who_know_me                                                                  0.000
## I_am_not_easily_angered                                                                                0.000
## I_do_not_mind_meeting_strangers                                                                        0.000
## I_get_all_the_sympathy_I_should                                                                        0.000
## Little_interest_or_pleasure_in_doing_things                                                            0.000
## Feeling_down_depressed_or_hopeless                                                                     0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                     0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                0.319
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                           0.570
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 -0.191
## Feeling_panic_or_being_frightened                                                                      0.000
## Avoiding_situations_that_make_you_anxious                                                              0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                          0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                       0.000
## Thoughts_of_actually_hurting_yourself                                                                  0.332
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                   0.739
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking  0.828
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                          0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home           0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                    0.183
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                         0.407
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories        0.210
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                            0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                             0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                      1.601
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                               0.670
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                       0.641
## Life_satisfaction                                                                                      0.000
## Job_satisfaction                                                                                      -0.008
## Social_satisfaction                                                                                    0.000
## Romantic_satisfaction                                                                                  0.000
## Mood_higher_means_better_mood                                                                          0.000
## Anxiety_levels_higher_means_less_anxious                                                               0.000
## In_most_ways_my_life_is_close_to_my_ideal                                                              0.000
## The_conditions_of_my_life_are_excellent                                                                0.000
## I_am_satisfied_with_my_life                                                                            0.000
## So_far_I_have_gotten_the_important_things_I_want_in_life                                               0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                             0.000
## Attention_deficit_hyperactivity_disorder_ADHD                                                          0.000
## Alcohol_abuse                                                                                          1.387
## Non_alcohol_drug_abuse                                                                                 0.000
## Autism_spectrum_disorder_ASD                                                                           0.000
## Anti_social_personality_disorder                                                                       0.000
## Bipolarity                                                                                             0.000
## Borderline_Personality_Disorder                                                                        0.000
## Depression                                                                                             0.000
## General_Anxiety_Disorder_GAD                                                                          -0.737
## Obsessive_compulsive_disorder_OCD                                                                      0.000
## Panic_disorder                                                                                         0.000
## Paranoia_Paranoid_personality_disorder                                                                 0.000
## Phobias_social                                                                                         0.000
## Specific_phobias                                                                                       0.000
## Post_traumatic_stress_disorder_PTSD                                                                   -0.549
## Schizophrenia                                                                                          0.000
## Schizoid_personality_disorder                                                                          0.000
## Sleeping_disorders                                                                                     0.000
##                                                                                                       theta.of.max.D
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                                        0.334
## Most_of_the_time_I_feel_blue                                                                                  -1.164
## I_often_feel_as_if_things_were_not_real                                                                       -1.164
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                               0.781
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                                     -1.164
## I_feel_that_I_have_often_been_punished_without_cause                                                          -1.164
## Life_is_a_strain_for_me_much_of_the_time                                                                      -1.164
## I_have_strange_and_peculiar_thoughts                                                                           0.956
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                       -1.164
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything                     -1.164
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to             -1.164
## At_times_I_think_I_am_no_good_at_all                                                                          -1.164
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                                -1.164
## I_am_happy_most_of_the_time                                                                                   -1.164
## I_very_seldom_have_spells_of_the_blues                                                                        -1.164
## During_the_past_few_years_I_have_been_well_most_of_the_time                                                   -1.164
## My_daily_life_is_full_of_things_that_keep_me_interested                                                       -1.164
## I_am_usually_calm_and_not_easily_upset                                                                         1.467
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                                      -1.164
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                               0.184
## I_am_liked_by_most_people_who_know_me                                                                         -1.164
## I_am_not_easily_angered                                                                                       -1.164
## I_do_not_mind_meeting_strangers                                                                               -1.164
## I_get_all_the_sympathy_I_should                                                                               -1.164
## Little_interest_or_pleasure_in_doing_things                                                                   -1.164
## Feeling_down_depressed_or_hopeless                                                                            -1.164
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                            -1.164
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                        2.684
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                                   2.684
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                         -0.496
## Feeling_panic_or_being_frightened                                                                             -1.164
## Avoiding_situations_that_make_you_anxious                                                                     -1.164
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                                 -1.164
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                              -1.164
## Thoughts_of_actually_hurting_yourself                                                                          1.864
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                           2.684
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking          2.684
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                                 -1.164
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home                  -1.164
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                            1.174
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                                 2.096
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories                1.929
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                                   -1.164
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                                    -1.164
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                              2.684
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                                       2.684
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                               2.517
## Life_satisfaction                                                                                             -1.164
## Job_satisfaction                                                                                               2.170
## Social_satisfaction                                                                                           -1.164
## Romantic_satisfaction                                                                                         -1.164
## Mood_higher_means_better_mood                                                                                 -1.164
## Anxiety_levels_higher_means_less_anxious                                                                      -1.164
## In_most_ways_my_life_is_close_to_my_ideal                                                                     -1.164
## The_conditions_of_my_life_are_excellent                                                                       -1.164
## I_am_satisfied_with_my_life                                                                                   -1.164
## So_far_I_have_gotten_the_important_things_I_want_in_life                                                      -1.164
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                                    -1.164
## Attention_deficit_hyperactivity_disorder_ADHD                                                                 -1.164
## Alcohol_abuse                                                                                                  2.684
## Non_alcohol_drug_abuse                                                                                        -1.164
## Autism_spectrum_disorder_ASD                                                                                  -1.164
## Anti_social_personality_disorder                                                                              -1.164
## Bipolarity                                                                                                    -1.164
## Borderline_Personality_Disorder                                                                               -1.164
## Depression                                                                                                    -1.164
## General_Anxiety_Disorder_GAD                                                                                   0.594
## Obsessive_compulsive_disorder_OCD                                                                             -1.164
## Panic_disorder                                                                                                -1.164
## Paranoia_Paranoid_personality_disorder                                                                        -1.164
## Phobias_social                                                                                                -1.164
## Specific_phobias                                                                                              -1.164
## Post_traumatic_stress_disorder_PTSD                                                                            2.684
## Schizophrenia                                                                                                 -1.164
## Schizoid_personality_disorder                                                                                 -1.164
## Sleeping_disorders                                                                                            -1.164
##                                                                                                        max.D
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               -0.096
## Most_of_the_time_I_feel_blue                                                                           0.000
## I_often_feel_as_if_things_were_not_real                                                                0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                      -0.157
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                              0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                   0.000
## Life_is_a_strain_for_me_much_of_the_time                                                               0.000
## I_have_strange_and_peculiar_thoughts                                                                   0.117
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                0.000
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything              0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to      0.000
## At_times_I_think_I_am_no_good_at_all                                                                   0.000
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                         0.000
## I_am_happy_most_of_the_time                                                                            0.000
## I_very_seldom_have_spells_of_the_blues                                                                 0.000
## During_the_past_few_years_I_have_been_well_most_of_the_time                                            0.000
## My_daily_life_is_full_of_things_that_keep_me_interested                                                0.000
## I_am_usually_calm_and_not_easily_upset                                                                -0.182
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                               0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                      -0.129
## I_am_liked_by_most_people_who_know_me                                                                  0.000
## I_am_not_easily_angered                                                                                0.000
## I_do_not_mind_meeting_strangers                                                                        0.000
## I_get_all_the_sympathy_I_should                                                                        0.000
## Little_interest_or_pleasure_in_doing_things                                                            0.000
## Feeling_down_depressed_or_hopeless                                                                     0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                     0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                0.533
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                           0.552
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 -0.256
## Feeling_panic_or_being_frightened                                                                      0.000
## Avoiding_situations_that_make_you_anxious                                                              0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                          0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                       0.000
## Thoughts_of_actually_hurting_yourself                                                                  0.967
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                   1.692
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking  1.565
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                          0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home           0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                    0.267
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                         0.977
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories        0.555
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                            0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                             0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                      1.149
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                               0.313
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                       0.547
## Life_satisfaction                                                                                      0.000
## Job_satisfaction                                                                                      -0.048
## Social_satisfaction                                                                                    0.000
## Romantic_satisfaction                                                                                  0.000
## Mood_higher_means_better_mood                                                                          0.000
## Anxiety_levels_higher_means_less_anxious                                                               0.000
## In_most_ways_my_life_is_close_to_my_ideal                                                              0.000
## The_conditions_of_my_life_are_excellent                                                                0.000
## I_am_satisfied_with_my_life                                                                            0.000
## So_far_I_have_gotten_the_important_things_I_want_in_life                                               0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                             0.000
## Attention_deficit_hyperactivity_disorder_ADHD                                                          0.000
## Alcohol_abuse                                                                                          0.294
## Non_alcohol_drug_abuse                                                                                 0.000
## Autism_spectrum_disorder_ASD                                                                           0.000
## Anti_social_personality_disorder                                                                       0.000
## Bipolarity                                                                                             0.000
## Borderline_Personality_Disorder                                                                        0.000
## Depression                                                                                             0.000
## General_Anxiety_Disorder_GAD                                                                          -0.136
## Obsessive_compulsive_disorder_OCD                                                                      0.000
## Panic_disorder                                                                                         0.000
## Paranoia_Paranoid_personality_disorder                                                                 0.000
## Phobias_social                                                                                         0.000
## Specific_phobias                                                                                       0.000
## Post_traumatic_stress_disorder_PTSD                                                                    0.165
## Schizophrenia                                                                                          0.000
## Schizoid_personality_disorder                                                                          0.000
## Sleeping_disorders                                                                                     0.000
##                                                                                                       mean.ES.foc
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                                     0.253
## Most_of_the_time_I_feel_blue                                                                                0.220
## I_often_feel_as_if_things_were_not_real                                                                     0.157
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                            0.192
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                                   0.259
## I_feel_that_I_have_often_been_punished_without_cause                                                        0.219
## Life_is_a_strain_for_me_much_of_the_time                                                                    0.287
## I_have_strange_and_peculiar_thoughts                                                                        0.310
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                     0.212
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything                   0.220
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to           0.159
## At_times_I_think_I_am_no_good_at_all                                                                        0.284
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                              0.311
## I_am_happy_most_of_the_time                                                                                 0.278
## I_very_seldom_have_spells_of_the_blues                                                                      0.426
## During_the_past_few_years_I_have_been_well_most_of_the_time                                                 0.227
## My_daily_life_is_full_of_things_that_keep_me_interested                                                     0.239
## I_am_usually_calm_and_not_easily_upset                                                                      0.143
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                                    0.182
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                            0.333
## I_am_liked_by_most_people_who_know_me                                                                       0.090
## I_am_not_easily_angered                                                                                     0.228
## I_do_not_mind_meeting_strangers                                                                             0.278
## I_get_all_the_sympathy_I_should                                                                             0.246
## Little_interest_or_pleasure_in_doing_things                                                                 1.119
## Feeling_down_depressed_or_hopeless                                                                          1.077
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                          1.028
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                     1.092
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                                0.709
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                       1.055
## Feeling_panic_or_being_frightened                                                                           0.734
## Avoiding_situations_that_make_you_anxious                                                                   1.184
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                               0.969
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                            0.643
## Thoughts_of_actually_hurting_yourself                                                                       0.431
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                        0.339
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking       0.348
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                               1.243
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home                0.592
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                         0.643
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                              0.592
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories             0.597
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                                 0.652
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                                  0.804
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                           0.587
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                                    0.707
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                            0.509
## Life_satisfaction                                                                                           2.106
## Job_satisfaction                                                                                            2.593
## Social_satisfaction                                                                                         2.472
## Romantic_satisfaction                                                                                       2.487
## Mood_higher_means_better_mood                                                                               2.103
## Anxiety_levels_higher_means_less_anxious                                                                    2.839
## In_most_ways_my_life_is_close_to_my_ideal                                                                   2.661
## The_conditions_of_my_life_are_excellent                                                                     2.580
## I_am_satisfied_with_my_life                                                                                 2.367
## So_far_I_have_gotten_the_important_things_I_want_in_life                                                    2.321
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                                  3.215
## Attention_deficit_hyperactivity_disorder_ADHD                                                               0.105
## Alcohol_abuse                                                                                               0.071
## Non_alcohol_drug_abuse                                                                                      0.018
## Autism_spectrum_disorder_ASD                                                                                0.030
## Anti_social_personality_disorder                                                                            0.012
## Bipolarity                                                                                                  0.038
## Borderline_Personality_Disorder                                                                             0.017
## Depression                                                                                                  0.241
## General_Anxiety_Disorder_GAD                                                                                0.147
## Obsessive_compulsive_disorder_OCD                                                                           0.037
## Panic_disorder                                                                                              0.049
## Paranoia_Paranoid_personality_disorder                                                                      0.002
## Phobias_social                                                                                              0.016
## Specific_phobias                                                                                            0.016
## Post_traumatic_stress_disorder_PTSD                                                                         0.045
## Schizophrenia                                                                                               0.002
## Schizoid_personality_disorder                                                                               0.002
## Sleeping_disorders                                                                                          0.085
##                                                                                                       mean.ES.ref
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                                     0.302
## Most_of_the_time_I_feel_blue                                                                                0.220
## I_often_feel_as_if_things_were_not_real                                                                     0.157
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                            0.261
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                                   0.259
## I_feel_that_I_have_often_been_punished_without_cause                                                        0.219
## Life_is_a_strain_for_me_much_of_the_time                                                                    0.287
## I_have_strange_and_peculiar_thoughts                                                                        0.242
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                     0.212
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything                   0.220
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to           0.159
## At_times_I_think_I_am_no_good_at_all                                                                        0.284
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                              0.311
## I_am_happy_most_of_the_time                                                                                 0.278
## I_very_seldom_have_spells_of_the_blues                                                                      0.426
## During_the_past_few_years_I_have_been_well_most_of_the_time                                                 0.227
## My_daily_life_is_full_of_things_that_keep_me_interested                                                     0.239
## I_am_usually_calm_and_not_easily_upset                                                                      0.213
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                                    0.182
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                            0.428
## I_am_liked_by_most_people_who_know_me                                                                       0.090
## I_am_not_easily_angered                                                                                     0.228
## I_do_not_mind_meeting_strangers                                                                             0.278
## I_get_all_the_sympathy_I_should                                                                             0.246
## Little_interest_or_pleasure_in_doing_things                                                                 1.119
## Feeling_down_depressed_or_hopeless                                                                          1.077
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                          1.028
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                     0.936
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                                0.489
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                       1.225
## Feeling_panic_or_being_frightened                                                                           0.734
## Avoiding_situations_that_make_you_anxious                                                                   1.184
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                               0.969
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                            0.643
## Thoughts_of_actually_hurting_yourself                                                                       0.252
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                        0.134
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking       0.125
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                               1.243
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home                0.592
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                         0.522
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                              0.370
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories             0.459
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                                 0.652
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                                  0.804
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                           0.253
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                                    0.528
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                            0.307
## Life_satisfaction                                                                                           2.106
## Job_satisfaction                                                                                            2.601
## Social_satisfaction                                                                                         2.472
## Romantic_satisfaction                                                                                       2.487
## Mood_higher_means_better_mood                                                                               2.103
## Anxiety_levels_higher_means_less_anxious                                                                    2.839
## In_most_ways_my_life_is_close_to_my_ideal                                                                   2.661
## The_conditions_of_my_life_are_excellent                                                                     2.580
## I_am_satisfied_with_my_life                                                                                 2.367
## So_far_I_have_gotten_the_important_things_I_want_in_life                                                    2.321
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                                  3.215
## Attention_deficit_hyperactivity_disorder_ADHD                                                               0.105
## Alcohol_abuse                                                                                               0.021
## Non_alcohol_drug_abuse                                                                                      0.018
## Autism_spectrum_disorder_ASD                                                                                0.030
## Anti_social_personality_disorder                                                                            0.012
## Bipolarity                                                                                                  0.038
## Borderline_Personality_Disorder                                                                             0.017
## Depression                                                                                                  0.241
## General_Anxiety_Disorder_GAD                                                                                0.250
## Obsessive_compulsive_disorder_OCD                                                                           0.037
## Panic_disorder                                                                                              0.049
## Paranoia_Paranoid_personality_disorder                                                                      0.002
## Phobias_social                                                                                              0.016
## Specific_phobias                                                                                            0.016
## Post_traumatic_stress_disorder_PTSD                                                                         0.092
## Schizophrenia                                                                                               0.002
## Schizoid_personality_disorder                                                                               0.002
## Sleeping_disorders                                                                                          0.085
## 
## $conservative
##                                                                                                         SIDS
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                                0.000
## Most_of_the_time_I_feel_blue                                                                           0.000
## I_often_feel_as_if_things_were_not_real                                                                0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                       0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                              0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                   0.000
## Life_is_a_strain_for_me_much_of_the_time                                                               0.000
## I_have_strange_and_peculiar_thoughts                                                                   0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                0.000
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything              0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to      0.000
## At_times_I_think_I_am_no_good_at_all                                                                   0.000
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                         0.000
## I_am_happy_most_of_the_time                                                                            0.000
## I_very_seldom_have_spells_of_the_blues                                                                 0.000
## During_the_past_few_years_I_have_been_well_most_of_the_time                                            0.000
## My_daily_life_is_full_of_things_that_keep_me_interested                                                0.000
## I_am_usually_calm_and_not_easily_upset                                                                 0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                               0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                       0.000
## I_am_liked_by_most_people_who_know_me                                                                  0.000
## I_am_not_easily_angered                                                                                0.000
## I_do_not_mind_meeting_strangers                                                                        0.000
## I_get_all_the_sympathy_I_should                                                                        0.000
## Little_interest_or_pleasure_in_doing_things                                                            0.000
## Feeling_down_depressed_or_hopeless                                                                     0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                     0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                0.000
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                           0.000
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 -0.175
## Feeling_panic_or_being_frightened                                                                      0.000
## Avoiding_situations_that_make_you_anxious                                                              0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                          0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                       0.000
## Thoughts_of_actually_hurting_yourself                                                                  0.175
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                   0.204
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking  0.222
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                          0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home           0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                    0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                         0.218
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories        0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                            0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                             0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                      0.333
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                               0.000
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                       0.000
## Life_satisfaction                                                                                      0.000
## Job_satisfaction                                                                                       0.000
## Social_satisfaction                                                                                    0.000
## Romantic_satisfaction                                                                                  0.000
## Mood_higher_means_better_mood                                                                          0.000
## Anxiety_levels_higher_means_less_anxious                                                               0.000
## In_most_ways_my_life_is_close_to_my_ideal                                                              0.000
## The_conditions_of_my_life_are_excellent                                                                0.000
## I_am_satisfied_with_my_life                                                                            0.000
## So_far_I_have_gotten_the_important_things_I_want_in_life                                               0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                             0.000
## Attention_deficit_hyperactivity_disorder_ADHD                                                          0.000
## Alcohol_abuse                                                                                          0.049
## Non_alcohol_drug_abuse                                                                                 0.000
## Autism_spectrum_disorder_ASD                                                                           0.000
## Anti_social_personality_disorder                                                                       0.000
## Bipolarity                                                                                             0.000
## Borderline_Personality_Disorder                                                                        0.000
## Depression                                                                                             0.000
## General_Anxiety_Disorder_GAD                                                                          -0.104
## Obsessive_compulsive_disorder_OCD                                                                      0.000
## Panic_disorder                                                                                         0.000
## Paranoia_Paranoid_personality_disorder                                                                 0.000
## Phobias_social                                                                                         0.000
## Specific_phobias                                                                                       0.000
## Post_traumatic_stress_disorder_PTSD                                                                    0.000
## Schizophrenia                                                                                          0.000
## Schizoid_personality_disorder                                                                          0.000
## Sleeping_disorders                                                                                     0.000
##                                                                                                        UIDS
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               0.000
## Most_of_the_time_I_feel_blue                                                                          0.000
## I_often_feel_as_if_things_were_not_real                                                               0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                      0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                             0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                  0.000
## Life_is_a_strain_for_me_much_of_the_time                                                              0.000
## I_have_strange_and_peculiar_thoughts                                                                  0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up               0.000
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything             0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to     0.000
## At_times_I_think_I_am_no_good_at_all                                                                  0.000
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                        0.000
## I_am_happy_most_of_the_time                                                                           0.000
## I_very_seldom_have_spells_of_the_blues                                                                0.000
## During_the_past_few_years_I_have_been_well_most_of_the_time                                           0.000
## My_daily_life_is_full_of_things_that_keep_me_interested                                               0.000
## I_am_usually_calm_and_not_easily_upset                                                                0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                              0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                      0.000
## I_am_liked_by_most_people_who_know_me                                                                 0.000
## I_am_not_easily_angered                                                                               0.000
## I_do_not_mind_meeting_strangers                                                                       0.000
## I_get_all_the_sympathy_I_should                                                                       0.000
## Little_interest_or_pleasure_in_doing_things                                                           0.000
## Feeling_down_depressed_or_hopeless                                                                    0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                    0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                               0.000
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                          0.000
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 0.175
## Feeling_panic_or_being_frightened                                                                     0.000
## Avoiding_situations_that_make_you_anxious                                                             0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                         0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                      0.000
## Thoughts_of_actually_hurting_yourself                                                                 0.175
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                  0.205
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking 0.222
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                         0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home          0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                   0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                        0.222
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories       0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                           0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                            0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                     0.333
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                              0.000
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                      0.000
## Life_satisfaction                                                                                     0.000
## Job_satisfaction                                                                                      0.000
## Social_satisfaction                                                                                   0.000
## Romantic_satisfaction                                                                                 0.000
## Mood_higher_means_better_mood                                                                         0.000
## Anxiety_levels_higher_means_less_anxious                                                              0.000
## In_most_ways_my_life_is_close_to_my_ideal                                                             0.000
## The_conditions_of_my_life_are_excellent                                                               0.000
## I_am_satisfied_with_my_life                                                                           0.000
## So_far_I_have_gotten_the_important_things_I_want_in_life                                              0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                            0.000
## Attention_deficit_hyperactivity_disorder_ADHD                                                         0.000
## Alcohol_abuse                                                                                         0.049
## Non_alcohol_drug_abuse                                                                                0.000
## Autism_spectrum_disorder_ASD                                                                          0.000
## Anti_social_personality_disorder                                                                      0.000
## Bipolarity                                                                                            0.000
## Borderline_Personality_Disorder                                                                       0.000
## Depression                                                                                            0.000
## General_Anxiety_Disorder_GAD                                                                          0.104
## Obsessive_compulsive_disorder_OCD                                                                     0.000
## Panic_disorder                                                                                        0.000
## Paranoia_Paranoid_personality_disorder                                                                0.000
## Phobias_social                                                                                        0.000
## Specific_phobias                                                                                      0.000
## Post_traumatic_stress_disorder_PTSD                                                                   0.000
## Schizophrenia                                                                                         0.000
## Schizoid_personality_disorder                                                                         0.000
## Sleeping_disorders                                                                                    0.000
##                                                                                                         SIDN
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                                0.000
## Most_of_the_time_I_feel_blue                                                                           0.000
## I_often_feel_as_if_things_were_not_real                                                                0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                       0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                              0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                   0.000
## Life_is_a_strain_for_me_much_of_the_time                                                               0.000
## I_have_strange_and_peculiar_thoughts                                                                   0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                0.000
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything              0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to      0.000
## At_times_I_think_I_am_no_good_at_all                                                                   0.000
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                         0.000
## I_am_happy_most_of_the_time                                                                            0.000
## I_very_seldom_have_spells_of_the_blues                                                                 0.000
## During_the_past_few_years_I_have_been_well_most_of_the_time                                            0.000
## My_daily_life_is_full_of_things_that_keep_me_interested                                                0.000
## I_am_usually_calm_and_not_easily_upset                                                                 0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                               0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                       0.000
## I_am_liked_by_most_people_who_know_me                                                                  0.000
## I_am_not_easily_angered                                                                                0.000
## I_do_not_mind_meeting_strangers                                                                        0.000
## I_get_all_the_sympathy_I_should                                                                        0.000
## Little_interest_or_pleasure_in_doing_things                                                            0.000
## Feeling_down_depressed_or_hopeless                                                                     0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                     0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                0.000
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                           0.000
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 -0.170
## Feeling_panic_or_being_frightened                                                                      0.000
## Avoiding_situations_that_make_you_anxious                                                              0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                          0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                       0.000
## Thoughts_of_actually_hurting_yourself                                                                  0.186
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                   0.220
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking  0.236
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                          0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home           0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                    0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                         0.227
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories        0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                            0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                             0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                      0.338
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                               0.000
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                       0.000
## Life_satisfaction                                                                                      0.000
## Job_satisfaction                                                                                       0.000
## Social_satisfaction                                                                                    0.000
## Romantic_satisfaction                                                                                  0.000
## Mood_higher_means_better_mood                                                                          0.000
## Anxiety_levels_higher_means_less_anxious                                                               0.000
## In_most_ways_my_life_is_close_to_my_ideal                                                              0.000
## The_conditions_of_my_life_are_excellent                                                                0.000
## I_am_satisfied_with_my_life                                                                            0.000
## So_far_I_have_gotten_the_important_things_I_want_in_life                                               0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                             0.000
## Attention_deficit_hyperactivity_disorder_ADHD                                                          0.000
## Alcohol_abuse                                                                                          0.051
## Non_alcohol_drug_abuse                                                                                 0.000
## Autism_spectrum_disorder_ASD                                                                           0.000
## Anti_social_personality_disorder                                                                       0.000
## Bipolarity                                                                                             0.000
## Borderline_Personality_Disorder                                                                        0.000
## Depression                                                                                             0.000
## General_Anxiety_Disorder_GAD                                                                          -0.101
## Obsessive_compulsive_disorder_OCD                                                                      0.000
## Panic_disorder                                                                                         0.000
## Paranoia_Paranoid_personality_disorder                                                                 0.000
## Phobias_social                                                                                         0.000
## Specific_phobias                                                                                       0.000
## Post_traumatic_stress_disorder_PTSD                                                                    0.000
## Schizophrenia                                                                                          0.000
## Schizoid_personality_disorder                                                                          0.000
## Sleeping_disorders                                                                                     0.000
##                                                                                                        UIDN
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                               0.000
## Most_of_the_time_I_feel_blue                                                                          0.000
## I_often_feel_as_if_things_were_not_real                                                               0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                      0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                             0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                  0.000
## Life_is_a_strain_for_me_much_of_the_time                                                              0.000
## I_have_strange_and_peculiar_thoughts                                                                  0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up               0.000
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything             0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to     0.000
## At_times_I_think_I_am_no_good_at_all                                                                  0.000
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                        0.000
## I_am_happy_most_of_the_time                                                                           0.000
## I_very_seldom_have_spells_of_the_blues                                                                0.000
## During_the_past_few_years_I_have_been_well_most_of_the_time                                           0.000
## My_daily_life_is_full_of_things_that_keep_me_interested                                               0.000
## I_am_usually_calm_and_not_easily_upset                                                                0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                              0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                      0.000
## I_am_liked_by_most_people_who_know_me                                                                 0.000
## I_am_not_easily_angered                                                                               0.000
## I_do_not_mind_meeting_strangers                                                                       0.000
## I_get_all_the_sympathy_I_should                                                                       0.000
## Little_interest_or_pleasure_in_doing_things                                                           0.000
## Feeling_down_depressed_or_hopeless                                                                    0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                    0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                               0.000
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                          0.000
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 0.171
## Feeling_panic_or_being_frightened                                                                     0.000
## Avoiding_situations_that_make_you_anxious                                                             0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                         0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                      0.000
## Thoughts_of_actually_hurting_yourself                                                                 0.186
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                  0.220
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking 0.236
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                         0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home          0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                   0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                        0.230
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories       0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                           0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                            0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                     0.338
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                              0.000
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                      0.000
## Life_satisfaction                                                                                     0.000
## Job_satisfaction                                                                                      0.000
## Social_satisfaction                                                                                   0.000
## Romantic_satisfaction                                                                                 0.000
## Mood_higher_means_better_mood                                                                         0.000
## Anxiety_levels_higher_means_less_anxious                                                              0.000
## In_most_ways_my_life_is_close_to_my_ideal                                                             0.000
## The_conditions_of_my_life_are_excellent                                                               0.000
## I_am_satisfied_with_my_life                                                                           0.000
## So_far_I_have_gotten_the_important_things_I_want_in_life                                              0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                            0.000
## Attention_deficit_hyperactivity_disorder_ADHD                                                         0.000
## Alcohol_abuse                                                                                         0.051
## Non_alcohol_drug_abuse                                                                                0.000
## Autism_spectrum_disorder_ASD                                                                          0.000
## Anti_social_personality_disorder                                                                      0.000
## Bipolarity                                                                                            0.000
## Borderline_Personality_Disorder                                                                       0.000
## Depression                                                                                            0.000
## General_Anxiety_Disorder_GAD                                                                          0.101
## Obsessive_compulsive_disorder_OCD                                                                     0.000
## Panic_disorder                                                                                        0.000
## Paranoia_Paranoid_personality_disorder                                                                0.000
## Phobias_social                                                                                        0.000
## Specific_phobias                                                                                      0.000
## Post_traumatic_stress_disorder_PTSD                                                                   0.000
## Schizophrenia                                                                                         0.000
## Schizoid_personality_disorder                                                                         0.000
## Sleeping_disorders                                                                                    0.000
##                                                                                                         ESSD
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                                0.000
## Most_of_the_time_I_feel_blue                                                                           0.000
## I_often_feel_as_if_things_were_not_real                                                                0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                       0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                              0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                   0.000
## Life_is_a_strain_for_me_much_of_the_time                                                               0.000
## I_have_strange_and_peculiar_thoughts                                                                   0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                0.000
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything              0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to      0.000
## At_times_I_think_I_am_no_good_at_all                                                                   0.000
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                         0.000
## I_am_happy_most_of_the_time                                                                            0.000
## I_very_seldom_have_spells_of_the_blues                                                                 0.000
## During_the_past_few_years_I_have_been_well_most_of_the_time                                            0.000
## My_daily_life_is_full_of_things_that_keep_me_interested                                                0.000
## I_am_usually_calm_and_not_easily_upset                                                                 0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                               0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                       0.000
## I_am_liked_by_most_people_who_know_me                                                                  0.000
## I_am_not_easily_angered                                                                                0.000
## I_do_not_mind_meeting_strangers                                                                        0.000
## I_get_all_the_sympathy_I_should                                                                        0.000
## Little_interest_or_pleasure_in_doing_things                                                            0.000
## Feeling_down_depressed_or_hopeless                                                                     0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                     0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                0.000
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                           0.000
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 -0.196
## Feeling_panic_or_being_frightened                                                                      0.000
## Avoiding_situations_that_make_you_anxious                                                              0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                          0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                       0.000
## Thoughts_of_actually_hurting_yourself                                                                  0.322
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                   0.742
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking  0.831
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                          0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home           0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                    0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                         0.401
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories        0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                            0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                             0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                      1.607
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                               0.000
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                       0.000
## Life_satisfaction                                                                                      0.000
## Job_satisfaction                                                                                       0.000
## Social_satisfaction                                                                                    0.000
## Romantic_satisfaction                                                                                  0.000
## Mood_higher_means_better_mood                                                                          0.000
## Anxiety_levels_higher_means_less_anxious                                                               0.000
## In_most_ways_my_life_is_close_to_my_ideal                                                              0.000
## The_conditions_of_my_life_are_excellent                                                                0.000
## I_am_satisfied_with_my_life                                                                            0.000
## So_far_I_have_gotten_the_important_things_I_want_in_life                                               0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                             0.000
## Attention_deficit_hyperactivity_disorder_ADHD                                                          0.000
## Alcohol_abuse                                                                                          1.396
## Non_alcohol_drug_abuse                                                                                 0.000
## Autism_spectrum_disorder_ASD                                                                           0.000
## Anti_social_personality_disorder                                                                       0.000
## Bipolarity                                                                                             0.000
## Borderline_Personality_Disorder                                                                        0.000
## Depression                                                                                             0.000
## General_Anxiety_Disorder_GAD                                                                          -0.739
## Obsessive_compulsive_disorder_OCD                                                                      0.000
## Panic_disorder                                                                                         0.000
## Paranoia_Paranoid_personality_disorder                                                                 0.000
## Phobias_social                                                                                         0.000
## Specific_phobias                                                                                       0.000
## Post_traumatic_stress_disorder_PTSD                                                                    0.000
## Schizophrenia                                                                                          0.000
## Schizoid_personality_disorder                                                                          0.000
## Sleeping_disorders                                                                                     0.000
##                                                                                                       theta.of.max.D
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                                       -1.161
## Most_of_the_time_I_feel_blue                                                                                  -1.161
## I_often_feel_as_if_things_were_not_real                                                                       -1.161
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                              -1.161
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                                     -1.161
## I_feel_that_I_have_often_been_punished_without_cause                                                          -1.161
## Life_is_a_strain_for_me_much_of_the_time                                                                      -1.161
## I_have_strange_and_peculiar_thoughts                                                                          -1.161
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                       -1.161
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything                     -1.161
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to             -1.161
## At_times_I_think_I_am_no_good_at_all                                                                          -1.161
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                                -1.161
## I_am_happy_most_of_the_time                                                                                   -1.161
## I_very_seldom_have_spells_of_the_blues                                                                        -1.161
## During_the_past_few_years_I_have_been_well_most_of_the_time                                                   -1.161
## My_daily_life_is_full_of_things_that_keep_me_interested                                                       -1.161
## I_am_usually_calm_and_not_easily_upset                                                                        -1.161
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                                      -1.161
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                              -1.161
## I_am_liked_by_most_people_who_know_me                                                                         -1.161
## I_am_not_easily_angered                                                                                       -1.161
## I_do_not_mind_meeting_strangers                                                                               -1.161
## I_get_all_the_sympathy_I_should                                                                               -1.161
## Little_interest_or_pleasure_in_doing_things                                                                   -1.161
## Feeling_down_depressed_or_hopeless                                                                            -1.161
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                            -1.161
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                       -1.161
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                                  -1.161
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                         -0.480
## Feeling_panic_or_being_frightened                                                                             -1.161
## Avoiding_situations_that_make_you_anxious                                                                     -1.161
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                                 -1.161
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                              -1.161
## Thoughts_of_actually_hurting_yourself                                                                          1.878
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                           2.728
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking          2.728
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                                 -1.161
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home                  -1.161
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                           -1.161
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                                 2.100
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories               -1.161
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                                   -1.161
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                                    -1.161
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                              2.728
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                                      -1.161
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                              -1.161
## Life_satisfaction                                                                                             -1.161
## Job_satisfaction                                                                                              -1.161
## Social_satisfaction                                                                                           -1.161
## Romantic_satisfaction                                                                                         -1.161
## Mood_higher_means_better_mood                                                                                 -1.161
## Anxiety_levels_higher_means_less_anxious                                                                      -1.161
## In_most_ways_my_life_is_close_to_my_ideal                                                                     -1.161
## The_conditions_of_my_life_are_excellent                                                                       -1.161
## I_am_satisfied_with_my_life                                                                                   -1.161
## So_far_I_have_gotten_the_important_things_I_want_in_life                                                      -1.161
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                                    -1.161
## Attention_deficit_hyperactivity_disorder_ADHD                                                                 -1.161
## Alcohol_abuse                                                                                                  2.728
## Non_alcohol_drug_abuse                                                                                        -1.161
## Autism_spectrum_disorder_ASD                                                                                  -1.161
## Anti_social_personality_disorder                                                                              -1.161
## Bipolarity                                                                                                    -1.161
## Borderline_Personality_Disorder                                                                               -1.161
## Depression                                                                                                    -1.161
## General_Anxiety_Disorder_GAD                                                                                   0.638
## Obsessive_compulsive_disorder_OCD                                                                             -1.161
## Panic_disorder                                                                                                -1.161
## Paranoia_Paranoid_personality_disorder                                                                        -1.161
## Phobias_social                                                                                                -1.161
## Specific_phobias                                                                                              -1.161
## Post_traumatic_stress_disorder_PTSD                                                                           -1.161
## Schizophrenia                                                                                                 -1.161
## Schizoid_personality_disorder                                                                                 -1.161
## Sleeping_disorders                                                                                            -1.161
##                                                                                                        max.D
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                                0.000
## Most_of_the_time_I_feel_blue                                                                           0.000
## I_often_feel_as_if_things_were_not_real                                                                0.000
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                       0.000
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                              0.000
## I_feel_that_I_have_often_been_punished_without_cause                                                   0.000
## Life_is_a_strain_for_me_much_of_the_time                                                               0.000
## I_have_strange_and_peculiar_thoughts                                                                   0.000
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                0.000
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything              0.000
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to      0.000
## At_times_I_think_I_am_no_good_at_all                                                                   0.000
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                         0.000
## I_am_happy_most_of_the_time                                                                            0.000
## I_very_seldom_have_spells_of_the_blues                                                                 0.000
## During_the_past_few_years_I_have_been_well_most_of_the_time                                            0.000
## My_daily_life_is_full_of_things_that_keep_me_interested                                                0.000
## I_am_usually_calm_and_not_easily_upset                                                                 0.000
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                               0.000
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                       0.000
## I_am_liked_by_most_people_who_know_me                                                                  0.000
## I_am_not_easily_angered                                                                                0.000
## I_do_not_mind_meeting_strangers                                                                        0.000
## I_get_all_the_sympathy_I_should                                                                        0.000
## Little_interest_or_pleasure_in_doing_things                                                            0.000
## Feeling_down_depressed_or_hopeless                                                                     0.000
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                     0.000
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                0.000
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                           0.000
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                 -0.254
## Feeling_panic_or_being_frightened                                                                      0.000
## Avoiding_situations_that_make_you_anxious                                                              0.000
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                          0.000
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                       0.000
## Thoughts_of_actually_hurting_yourself                                                                  0.908
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                   1.640
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking  1.514
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                          0.000
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home           0.000
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                    0.000
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                         0.932
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories        0.000
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                            0.000
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                             0.000
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                      1.135
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                               0.000
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                       0.000
## Life_satisfaction                                                                                      0.000
## Job_satisfaction                                                                                       0.000
## Social_satisfaction                                                                                    0.000
## Romantic_satisfaction                                                                                  0.000
## Mood_higher_means_better_mood                                                                          0.000
## Anxiety_levels_higher_means_less_anxious                                                               0.000
## In_most_ways_my_life_is_close_to_my_ideal                                                              0.000
## The_conditions_of_my_life_are_excellent                                                                0.000
## I_am_satisfied_with_my_life                                                                            0.000
## So_far_I_have_gotten_the_important_things_I_want_in_life                                               0.000
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                             0.000
## Attention_deficit_hyperactivity_disorder_ADHD                                                          0.000
## Alcohol_abuse                                                                                          0.291
## Non_alcohol_drug_abuse                                                                                 0.000
## Autism_spectrum_disorder_ASD                                                                           0.000
## Anti_social_personality_disorder                                                                       0.000
## Bipolarity                                                                                             0.000
## Borderline_Personality_Disorder                                                                        0.000
## Depression                                                                                             0.000
## General_Anxiety_Disorder_GAD                                                                          -0.138
## Obsessive_compulsive_disorder_OCD                                                                      0.000
## Panic_disorder                                                                                         0.000
## Paranoia_Paranoid_personality_disorder                                                                 0.000
## Phobias_social                                                                                         0.000
## Specific_phobias                                                                                       0.000
## Post_traumatic_stress_disorder_PTSD                                                                    0.000
## Schizophrenia                                                                                          0.000
## Schizoid_personality_disorder                                                                          0.000
## Sleeping_disorders                                                                                     0.000
##                                                                                                       mean.ES.foc
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                                     0.278
## Most_of_the_time_I_feel_blue                                                                                0.221
## I_often_feel_as_if_things_were_not_real                                                                     0.158
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                            0.228
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                                   0.260
## I_feel_that_I_have_often_been_punished_without_cause                                                        0.220
## Life_is_a_strain_for_me_much_of_the_time                                                                    0.288
## I_have_strange_and_peculiar_thoughts                                                                        0.275
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                     0.213
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything                   0.221
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to           0.159
## At_times_I_think_I_am_no_good_at_all                                                                        0.284
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                              0.311
## I_am_happy_most_of_the_time                                                                                 0.279
## I_very_seldom_have_spells_of_the_blues                                                                      0.427
## During_the_past_few_years_I_have_been_well_most_of_the_time                                                 0.228
## My_daily_life_is_full_of_things_that_keep_me_interested                                                     0.240
## I_am_usually_calm_and_not_easily_upset                                                                      0.180
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                                    0.183
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                            0.381
## I_am_liked_by_most_people_who_know_me                                                                       0.090
## I_am_not_easily_angered                                                                                     0.229
## I_do_not_mind_meeting_strangers                                                                             0.278
## I_get_all_the_sympathy_I_should                                                                             0.246
## Little_interest_or_pleasure_in_doing_things                                                                 1.121
## Feeling_down_depressed_or_hopeless                                                                          1.080
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                          1.031
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                     1.012
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                                0.596
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                       1.055
## Feeling_panic_or_being_frightened                                                                           0.737
## Avoiding_situations_that_make_you_anxious                                                                   1.186
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                               0.972
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                            0.646
## Thoughts_of_actually_hurting_yourself                                                                       0.430
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                        0.339
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking       0.348
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                               1.245
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home                0.594
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                         0.584
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                              0.592
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories             0.527
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                                 0.655
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                                  0.808
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                           0.587
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                                    0.616
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                            0.405
## Life_satisfaction                                                                                           2.109
## Job_satisfaction                                                                                            2.600
## Social_satisfaction                                                                                         2.475
## Romantic_satisfaction                                                                                       2.489
## Mood_higher_means_better_mood                                                                               2.106
## Anxiety_levels_higher_means_less_anxious                                                                    2.841
## In_most_ways_my_life_is_close_to_my_ideal                                                                   2.664
## The_conditions_of_my_life_are_excellent                                                                     2.583
## I_am_satisfied_with_my_life                                                                                 2.370
## So_far_I_have_gotten_the_important_things_I_want_in_life                                                    2.324
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                                  3.217
## Attention_deficit_hyperactivity_disorder_ADHD                                                               0.105
## Alcohol_abuse                                                                                               0.071
## Non_alcohol_drug_abuse                                                                                      0.018
## Autism_spectrum_disorder_ASD                                                                                0.030
## Anti_social_personality_disorder                                                                            0.013
## Bipolarity                                                                                                  0.038
## Borderline_Personality_Disorder                                                                             0.017
## Depression                                                                                                  0.241
## General_Anxiety_Disorder_GAD                                                                                0.147
## Obsessive_compulsive_disorder_OCD                                                                           0.037
## Panic_disorder                                                                                              0.049
## Paranoia_Paranoid_personality_disorder                                                                      0.002
## Phobias_social                                                                                              0.016
## Specific_phobias                                                                                            0.016
## Post_traumatic_stress_disorder_PTSD                                                                         0.069
## Schizophrenia                                                                                               0.002
## Schizoid_personality_disorder                                                                               0.002
## Sleeping_disorders                                                                                          0.086
##                                                                                                       mean.ES.ref
## Several_times_a_week_I_feel_as_if_something_dreadful_is_about_to_happen                                     0.278
## Most_of_the_time_I_feel_blue                                                                                0.221
## I_often_feel_as_if_things_were_not_real                                                                     0.158
## I_sometimes_feel_that_I_am_about_to_go_to_pieces                                                            0.228
## Even_when_I_am_with_people_I_feel_lonely_much_of_the_time                                                   0.260
## I_feel_that_I_have_often_been_punished_without_cause                                                        0.220
## Life_is_a_strain_for_me_much_of_the_time                                                                    0.288
## I_have_strange_and_peculiar_thoughts                                                                        0.275
## My_plans_have_frequently_seemed_so_full_of_difficulties_that_I_have_had_to_give_them_up                     0.213
## Often_even_though_everything_is_going_fine_for_me_I_feel_that_I_don_t_care_about_anything                   0.221
## I_do_many_things_which_I_regret_afterwards_I_regret_things_more_or_more_often_than_others_seem_to           0.159
## At_times_I_think_I_am_no_good_at_all                                                                        0.284
## I_have_often_felt_that_strangers_were_looking_at_me_critically                                              0.311
## I_am_happy_most_of_the_time                                                                                 0.279
## I_very_seldom_have_spells_of_the_blues                                                                      0.427
## During_the_past_few_years_I_have_been_well_most_of_the_time                                                 0.228
## My_daily_life_is_full_of_things_that_keep_me_interested                                                     0.240
## I_am_usually_calm_and_not_easily_upset                                                                      0.180
## I_believe_that_my_home_life_is_as_pleasant_as_that_of_most_people_I_know                                    0.183
## Most_nights_I_go_to_sleep_without_thoughts_or_ideas_bothering_me                                            0.381
## I_am_liked_by_most_people_who_know_me                                                                       0.090
## I_am_not_easily_angered                                                                                     0.229
## I_do_not_mind_meeting_strangers                                                                             0.278
## I_get_all_the_sympathy_I_should                                                                             0.246
## Little_interest_or_pleasure_in_doing_things                                                                 1.121
## Feeling_down_depressed_or_hopeless                                                                          1.080
## Feeling_more_irritated_grouchy_or_angry_than_usual                                                          1.031
## Sleeping_less_than_usual_but_still_have_a_lot_of_energy                                                     1.012
## Starting_lots_more_projects_than_usual_or_doing_more_risky_things_than_usual                                0.596
## Feeling_nervous_anxious_frightened_worried_or_on_edge                                                       1.230
## Feeling_panic_or_being_frightened                                                                           0.737
## Avoiding_situations_that_make_you_anxious                                                                   1.186
## Unexplained_aches_and_pains_e_g_head_back_joints_abdomen_legs                                               0.972
## Feeling_that_your_illnesses_are_not_being_taken_seriously_enough                                            0.646
## Thoughts_of_actually_hurting_yourself                                                                       0.256
## Hearing_things_other_people_couldn_t_hear_such_as_voices_even_when_no_one_was_around                        0.135
## Feeling_that_someone_could_hear_your_thoughts_or_that_you_could_hear_what_another_person_was_thinking       0.126
## Problems_with_sleep_that_affected_your_sleep_quality_over_all                                               1.245
## Problems_with_memory_e_g_learning_new_information_or_with_location_e_g_finding_your_way_home                0.594
## Unpleasant_thoughts_urges_or_images_that_repeatedly_enter_your_mind                                         0.584
## Feeling_driven_to_perform_certain_behaviors_or_mental_acts_over_and_over_again                              0.374
## Feeling_detached_or_distant_from_yourself_your_body_your_physical_surroundings_or_your_memories             0.527
## Not_knowing_who_you_really_are_or_what_you_want_out_of_life                                                 0.655
## Not_feeling_close_to_other_people_or_enjoying_your_relationships_with_them                                  0.808
## Drinking_at_least_4_drinks_of_any_kind_of_alcohol_in_a_single_day                                           0.254
## Smoking_any_cigarettes_a_cigar_or_pipe_or_using_snuff_or_chewing_tobacco                                    0.616
## Using_any_of_the_following_medicines_ON_YOUR_OWN                                                            0.405
## Life_satisfaction                                                                                           2.109
## Job_satisfaction                                                                                            2.600
## Social_satisfaction                                                                                         2.475
## Romantic_satisfaction                                                                                       2.489
## Mood_higher_means_better_mood                                                                               2.106
## Anxiety_levels_higher_means_less_anxious                                                                    2.841
## In_most_ways_my_life_is_close_to_my_ideal                                                                   2.664
## The_conditions_of_my_life_are_excellent                                                                     2.583
## I_am_satisfied_with_my_life                                                                                 2.370
## So_far_I_have_gotten_the_important_things_I_want_in_life                                                    2.324
## If_I_could_live_my_life_over_I_would_change_almost_nothing                                                  3.217
## Attention_deficit_hyperactivity_disorder_ADHD                                                               0.105
## Alcohol_abuse                                                                                               0.021
## Non_alcohol_drug_abuse                                                                                      0.018
## Autism_spectrum_disorder_ASD                                                                                0.030
## Anti_social_personality_disorder                                                                            0.013
## Bipolarity                                                                                                  0.038
## Borderline_Personality_Disorder                                                                             0.017
## Depression                                                                                                  0.241
## General_Anxiety_Disorder_GAD                                                                                0.251
## Obsessive_compulsive_disorder_OCD                                                                           0.037
## Panic_disorder                                                                                              0.049
## Paranoia_Paranoid_personality_disorder                                                                      0.002
## Phobias_social                                                                                              0.016
## Specific_phobias                                                                                            0.016
## Post_traumatic_stress_disorder_PTSD                                                                         0.069
## Schizophrenia                                                                                               0.002
## Schizoid_personality_disorder                                                                               0.002
## Sleeping_disorders                                                                                          0.086
#plot item functions
plot(
  dif_irt_mh_all_sex$fits$anchor_liberal, 
  type = "trace", 
  which.items = dif_irt_mh_all_sex$DIF_stats%>% mutate(idx = row_number()) %>% filter(p_adj < 0.05)  %>% pull(idx)
  )

Meta

#versions
write_sessioninfo()
## R version 4.5.0 (2025-04-11)
## Platform: x86_64-pc-linux-gnu
## Running under: Linux Mint 21.1
## 
## Matrix products: default
## BLAS:   /usr/lib/x86_64-linux-gnu/blas/libblas.so.3.10.0 
## LAPACK: /usr/lib/x86_64-linux-gnu/lapack/liblapack.so.3.10.0  LAPACK version 3.10.0
## 
## locale:
##  [1] LC_CTYPE=en_US.UTF-8       LC_NUMERIC=C              
##  [3] LC_TIME=en_US.UTF-8        LC_COLLATE=en_US.UTF-8    
##  [5] LC_MONETARY=en_DK.UTF-8    LC_MESSAGES=en_US.UTF-8   
##  [7] LC_PAPER=en_DK.UTF-8       LC_NAME=C                 
##  [9] LC_ADDRESS=C               LC_TELEPHONE=C            
## [11] LC_MEASUREMENT=en_DK.UTF-8 LC_IDENTIFICATION=C       
## 
## time zone: Europe/Brussels
## tzcode source: system (glibc)
## 
## attached base packages:
## [1] stats4    stats     graphics  grDevices utils     datasets  methods  
## [8] base     
## 
## other attached packages:
##  [1] BMA_3.18.20           rrcov_1.7-6           inline_0.3.21        
##  [4] robustbase_0.99-4-1   leaps_3.2             survival_3.8-3       
##  [7] mgcv_1.9-1            nlme_3.1-168          ggcorrplot_0.1.4.1   
## [10] polycor_0.8-1         ggeffects_2.2.1       rms_8.0-0            
## [13] future_1.40.0         mirt_1.44.0           lattice_0.22-5       
## [16] kirkegaard_2025-05-09 psych_2.5.3           assertthat_0.2.1     
## [19] weights_1.0.4         Hmisc_5.2-3           magrittr_2.0.3       
## [22] lubridate_1.9.4       forcats_1.0.0         stringr_1.5.1        
## [25] dplyr_1.1.4           purrr_1.0.4           readr_2.1.5          
## [28] tidyr_1.3.1           tibble_3.2.1          ggplot2_3.5.2        
## [31] tidyverse_2.0.0      
## 
## loaded via a namespace (and not attached):
##   [1] splines_4.5.0           polspline_1.1.25        R.oo_1.27.0            
##   [4] datawizard_1.0.2        rpart_4.1.24            lifecycle_1.0.4        
##   [7] Rdpack_2.6.4            globals_0.17.0          vroom_1.6.5            
##  [10] MASS_7.3-65             insight_1.2.0           backports_1.5.0        
##  [13] sass_0.4.10             rmarkdown_2.29          jquerylib_0.1.4        
##  [16] yaml_2.3.10             zip_2.3.2               askpass_1.2.1          
##  [19] sessioninfo_1.2.3       pbapply_1.7-2           minqa_1.2.8            
##  [22] RColorBrewer_1.1-3      multcomp_1.4-28         audio_0.1-11           
##  [25] R.utils_2.13.0          nnet_7.3-20             TH.data_1.1-3          
##  [28] sandwich_3.1-1          gdtools_0.4.2           listenv_0.9.1          
##  [31] gdata_3.0.1             testthat_3.2.3          vegan_2.6-10           
##  [34] MatrixModels_0.5-4      parallelly_1.43.0       permute_0.9-7          
##  [37] codetools_0.2-19        xml2_1.3.8              tidyselect_1.2.1       
##  [40] shape_1.4.6.1           farver_2.1.2            lme4_1.1-37            
##  [43] base64enc_0.1-3         jsonlite_2.0.0          mitml_0.4-5            
##  [46] progressr_0.15.1        Formula_1.2-5           iterators_1.0.14       
##  [49] systemfonts_1.2.2       foreach_1.5.2           tools_4.5.0            
##  [52] ragg_1.4.0              Rcpp_1.0.14             glue_1.8.0             
##  [55] mnormt_2.1.1            gridExtra_2.3           pan_1.9                
##  [58] xfun_0.52               admisc_0.38             withr_3.0.2            
##  [61] beepr_2.0               fastmap_1.2.0           boot_1.3-31            
##  [64] openssl_2.3.2           SparseM_1.84-2          digest_0.6.37          
##  [67] timechange_0.3.0        R6_2.6.1                mice_3.17.0            
##  [70] textshaping_1.0.0       colorspace_2.1-1        gtools_3.9.5           
##  [73] R.methodsS3_1.8.2       utf8_1.2.4              generics_0.1.3         
##  [76] fontLiberation_0.1.0    data.table_1.17.0       SimDesign_2.19.2       
##  [79] htmlwidgets_1.6.4       pkgconfig_2.0.3         gtable_0.3.6           
##  [82] pcaPP_2.0-5             brio_1.1.5              htmltools_0.5.8.1      
##  [85] fontBitstreamVera_0.1.1 scales_1.3.0            reformulas_0.4.0       
##  [88] knitr_1.50              rstudioapi_0.17.1       uuid_1.2-1             
##  [91] tzdb_0.5.0              checkmate_2.3.2         nloptr_2.2.1           
##  [94] cachem_1.1.0            zoo_1.8-14              flextable_0.9.7        
##  [97] parallel_4.5.0          foreign_0.8-90          pillar_1.10.2          
## [100] grid_4.5.0              vctrs_0.6.5             jomo_2.7-6             
## [103] Deriv_4.1.6             cluster_2.1.8.1         dcurver_0.9.2          
## [106] GPArotation_2025.3-1    htmlTable_2.4.3         evaluate_1.0.3         
## [109] mvtnorm_1.3-3           cli_3.6.4               compiler_4.5.0         
## [112] rlang_1.1.6             crayon_1.5.3            future.apply_1.11.3    
## [115] labeling_0.4.3          plyr_1.8.9              stringi_1.8.7          
## [118] munsell_0.5.1           fontquiver_0.2.1        glmnet_4.1-8           
## [121] quantreg_6.1            Matrix_1.7-3            patchwork_1.3.0        
## [124] hms_1.1.3               bit64_4.6.0-1           haven_2.5.4            
## [127] rbibutils_2.3           broom_1.0.8             bslib_0.9.0            
## [130] DEoptimR_1.1-3-1        bit_4.6.0               officer_0.6.8
#write data to file for reuse
d %>% write_rds("data/data_for_reuse.rds")

#OSF
if (F) {
  library(osfr)
  
  #login
  osf_auth(readr::read_lines("~/.config/osf_token"))
  
  #the project we will use
  osf_proj = osf_retrieve_node("https://osf.io/fh685/")
  
  #upload all files in project
  #overwrite existing (versioning)
  osf_upload(
    osf_proj,
    path = c("data", "figures", "papers", "notebook.Rmd", "notebook.html", "sessions_info.txt"), 
    conflicts = "overwrite"
    )
}