## ----setup, include = FALSE--------------------------------------------------- knitr::opts_chunk$set( collapse = TRUE, comment = "#>", fig.width = 7, fig.height = 5, fig.align = "center", warning = FALSE, message = FALSE ) ## ----load_package------------------------------------------------------------- library(gkwdist) ## ----family_table, echo=FALSE------------------------------------------------- family_structure <- data.frame( Distribution = c( "Generalized Kumaraswamy (GKw)", "Beta-Kumaraswamy (BKw)", "Kumaraswamy-Kumaraswamy (KKw)", "Exponentiated Kumaraswamy (EKw)", "McDonald (Mc)", "Kumaraswamy (Kw)", "Beta" ), Parameters = c( "α, β, γ, δ, λ", "α, β, γ, δ", "α, β, δ, λ", "α, β, λ", "γ, δ, λ", "α, β", "γ, δ" ), Relationship = c( "Full model", "λ = 1", "γ = 1", "γ = 1, δ = 0", "α = β = 1", "γ = δ = λ = 1", "α = β = λ = 1" ) ) knitr::kable(family_structure, caption = "Nested Structure of GKw Family") ## ----basic_functions---------------------------------------------------------- # Set parameters for Kumaraswamy distribution alpha <- 2.5 beta <- 3.5 # Density x <- seq(0.01, 0.99, length.out = 100) density <- dkw(x, alpha, beta) # CDF cdf_values <- pkw(x, alpha, beta) # Quantile function probabilities <- c(0.25, 0.5, 0.75) quantiles <- qkw(probabilities, alpha, beta) # Random generation set.seed(123) random_sample <- rkw(1000, alpha, beta) ## ----plot_basic, fig.height=6, fig.width=7------------------------------------ # PDF plot(x, density, type = "l", lwd = 2, col = "#2E4057", main = "Probability Density Function", xlab = "x", ylab = "f(x)", las = 1 ) grid(col = "gray90") # CDF plot(x, cdf_values, type = "l", lwd = 2, col = "#8B0000", main = "Cumulative Distribution Function", xlab = "x", ylab = "F(x)", las = 1 ) grid(col = "gray90") # Histogram with theoretical density hist(random_sample, breaks = 30, probability = TRUE, col = "lightblue", border = "white", main = "Random Sample", xlab = "x", ylab = "Density", las = 1 ) lines(x, density, col = "#8B0000", lwd = 2) grid(col = "gray90") # Q-Q plot theoretical_q <- qkw(ppoints(length(random_sample)), alpha, beta) empirical_q <- sort(random_sample) plot(theoretical_q, empirical_q, pch = 19, col = rgb(0, 0, 1, 0.3), main = "Q-Q Plot", xlab = "Theoretical Quantiles", ylab = "Sample Quantiles", las = 1 ) abline(0, 1, col = "#8B0000", lwd = 2, lty = 2) grid(col = "gray90") ## ----compare_families, fig.height=5, fig.width=7------------------------------ x_grid <- seq(0.001, 0.999, length.out = 500) # Compute densities d_gkw <- dgkw(x_grid, 2, 3, 1.5, 2, 1.2) d_bkw <- dbkw(x_grid, 2, 3, 1.5, 2) d_ekw <- dekw(x_grid, 2, 3, 1.5) d_kw <- dkw(x_grid, 2, 3) d_beta <- dbeta_(x_grid, 2, 3) # Plot comparison plot(x_grid, d_gkw, type = "l", lwd = 2, col = "#2E4057", ylim = c(0, max(d_gkw, d_bkw, d_ekw, d_kw, d_beta)), main = "Density Comparison Across Families", xlab = "x", ylab = "Density", las = 1 ) lines(x_grid, d_bkw, lwd = 2, col = "#8B0000") lines(x_grid, d_ekw, lwd = 2, col = "#006400") lines(x_grid, d_kw, lwd = 2, col = "#FFA07A") lines(x_grid, d_beta, lwd = 2, col = "#808080") legend("topright", legend = c( "GKw (5 par)", "BKw (4 par)", "EKw (3 par)", "Kw (2 par)", "Beta (2 par)" ), col = c("#2E4057", "#8B0000", "#006400", "#FFA07A", "#808080"), lwd = 2, bty = "n", cex = 0.9 ) grid(col = "gray90") ## ----mle_basic---------------------------------------------------------------- # Generate synthetic data set.seed(2024) n <- 1000 true_params <- c(alpha = 2.5, beta = 3.5) data <- rkw(n, true_params[1], true_params[2]) # Maximum likelihood estimation fit <- optim( par = c(2, 3), # Starting values fn = llkw, # Negative log-likelihood gr = grkw, # Analytical gradient data = data, method = "BFGS", hessian = TRUE ) # Extract results mle <- fit$par names(mle) <- c("alpha", "beta") se <- sqrt(diag(solve(fit$hessian))) ## ----mle_results-------------------------------------------------------------- # Construct summary table results <- data.frame( Parameter = c("alpha", "beta"), True = true_params, MLE = mle, SE = se, CI_Lower = mle - 1.96 * se, CI_Upper = mle + 1.96 * se, Coverage = (mle - 1.96 * se <= true_params) & (true_params <= mle + 1.96 * se) ) knitr::kable(results, digits = 4, caption = "Maximum Likelihood Estimates with 95% Confidence Intervals" ) # Information criteria cat("\nModel Fit Statistics:\n") cat("Log-likelihood:", -fit$value, "\n") cat("AIC:", 2 * fit$value + 2 * length(mle), "\n") cat("BIC:", 2 * fit$value + length(mle) * log(n), "\n") ## ----gof_plot, fig.height=5, fig.width=7-------------------------------------- # Fitted vs true density x_grid <- seq(0.001, 0.999, length.out = 200) fitted_dens <- dkw(x_grid, mle[1], mle[2]) true_dens <- dkw(x_grid, true_params[1], true_params[2]) hist(data, breaks = 40, probability = TRUE, col = "lightgray", border = "white", main = "Goodness-of-Fit: Kumaraswamy Distribution", xlab = "Data", ylab = "Density", las = 1 ) lines(x_grid, fitted_dens, col = "#8B0000", lwd = 2) lines(x_grid, true_dens, col = "#006400", lwd = 2, lty = 2) legend("topright", legend = c("Observed Data", "Fitted Model", "True Model"), col = c("gray", "#8B0000", "#006400"), lwd = c(8, 2, 2), lty = c(1, 1, 2), bty = "n" ) grid(col = "gray90") ## ----model_selection---------------------------------------------------------- # Generate data from EKw distribution set.seed(456) n <- 1500 data_ekw <- rekw(n, alpha = 2, beta = 3, lambda = 1.5) # Define candidate models models <- list( Beta = list( fn = llbeta, gr = grbeta, start = c(2, 2), npar = 2 ), Kw = list( fn = llkw, gr = grkw, start = c(2, 3), npar = 2 ), EKw = list( fn = llekw, gr = grekw, start = c(2, 3, 1.5), npar = 3 ), Mc = list( fn = llmc, gr = grmc, start = c(2, 2, 1.5), npar = 3 ) ) # Fit all models results_list <- lapply(names(models), function(name) { m <- models[[name]] fit <- optim( par = m$start, fn = m$fn, gr = m$gr, data = data_ekw, method = "BFGS" ) loglik <- -fit$value data.frame( Model = name, nPar = m$npar, LogLik = loglik, AIC = -2 * loglik + 2 * m$npar, BIC = -2 * loglik + m$npar * log(n), Converged = fit$convergence == 0 ) }) # Combine results comparison <- do.call(rbind, results_list) comparison <- comparison[order(comparison$AIC), ] rownames(comparison) <- NULL knitr::kable(comparison, digits = 2, caption = "Model Selection via Information Criteria" ) ## ----interpretation----------------------------------------------------------- best_model <- comparison$Model[1] cat("\nBest model by AIC:", best_model, "\n") cat("Best model by BIC:", comparison$Model[which.min(comparison$BIC)], "\n") # Delta AIC comparison$Delta_AIC <- comparison$AIC - min(comparison$AIC) cat("\nΔAIC relative to best model:\n") print(comparison[, c("Model", "Delta_AIC")]) ## ----profile_likelihood, fig.height=4, fig.width=7---------------------------- # Generate data set.seed(789) data_profile <- rkw(500, alpha = 2.5, beta = 3.5) # Fit model fit_profile <- optim( par = c(2, 3), fn = llkw, gr = grkw, data = data_profile, method = "BFGS", hessian = TRUE ) mle_profile <- fit_profile$par # Compute profile likelihood for alpha alpha_grid <- seq(mle_profile[1] - 1, mle_profile[1] + 1, length.out = 50) alpha_grid <- alpha_grid[alpha_grid > 0] profile_ll <- numeric(length(alpha_grid)) for (i in seq_along(alpha_grid)) { profile_fit <- optimize( f = function(beta) llkw(c(alpha_grid[i], beta), data_profile), interval = c(0.1, 10), maximum = FALSE ) profile_ll[i] <- -profile_fit$objective } # Plot # Profile likelihood chi_crit <- qchisq(0.95, df = 1) threshold <- max(profile_ll) - chi_crit / 2 plot(alpha_grid, profile_ll, type = "l", lwd = 2, col = "#2E4057", main = "Profile Log-Likelihood", xlab = expression(alpha), ylab = "Profile Log-Likelihood", las = 1 ) abline(v = mle_profile[1], col = "#8B0000", lty = 2, lwd = 2) abline(v = 2.5, col = "#006400", lty = 2, lwd = 2) abline(h = threshold, col = "#808080", lty = 3, lwd = 1.5) legend("topright", legend = c("MLE", "True", "95% CI"), col = c("#8B0000", "#006400", "#808080"), lty = c(2, 2, 3), lwd = 2, bty = "n", cex = 0.8 ) grid(col = "gray90") # Wald vs Profile CI comparison se_profile <- sqrt(diag(solve(fit_profile$hessian))) wald_ci <- mle_profile[1] + c(-1.96, 1.96) * se_profile[1] profile_ci <- range(alpha_grid[profile_ll >= threshold]) plot(1:2, c(mle_profile[1], mle_profile[1]), xlim = c(0.5, 2.5), ylim = range(c(wald_ci, profile_ci)), pch = 19, col = "#8B0000", cex = 1.5, main = "Confidence Interval Comparison", xlab = "", ylab = expression(alpha), xaxt = "n", las = 1 ) axis(1, at = 1:2, labels = c("Wald", "Profile")) # Add CIs segments(1, wald_ci[1], 1, wald_ci[2], lwd = 3, col = "#2E4057") segments(2, profile_ci[1], 2, profile_ci[2], lwd = 3, col = "#8B0000") abline(h = 2.5, col = "#006400", lty = 2, lwd = 2) legend("topright", legend = c("MLE", "True", "Wald 95% CI", "Profile 95% CI"), col = c("#8B0000", "#006400", "#2E4057", "#8B0000"), pch = c(19, NA, NA, NA), lty = c(NA, 2, 1, 1), lwd = c(NA, 2, 3, 3), bty = "n", cex = 0.8 ) grid(col = "gray90") ## ----confidence_ellipse, fig.height=5, fig.width=6---------------------------- # Compute variance-covariance matrix vcov_matrix <- solve(fit_profile$hessian) # Create confidence ellipse (95%) theta <- seq(0, 2 * pi, length.out = 100) chi2_val <- qchisq(0.95, df = 2) eig_decomp <- eigen(vcov_matrix) ellipse <- matrix(NA, nrow = 100, ncol = 2) for (i in 1:100) { v <- c(cos(theta[i]), sin(theta[i])) ellipse[i, ] <- mle_profile + sqrt(chi2_val) * (eig_decomp$vectors %*% diag(sqrt(eig_decomp$values)) %*% v) } # Marginal CIs se_marg <- sqrt(diag(vcov_matrix)) ci_alpha_marg <- mle_profile[1] + c(-1.96, 1.96) * se_marg[1] ci_beta_marg <- mle_profile[2] + c(-1.96, 1.96) * se_marg[2] # Plot plot(ellipse[, 1], ellipse[, 2], type = "l", lwd = 2, col = "#2E4057", main = "95% Joint Confidence Region", xlab = expression(alpha), ylab = expression(beta), las = 1 ) # Add marginal CIs abline(v = ci_alpha_marg, col = "#808080", lty = 3, lwd = 1.5) abline(h = ci_beta_marg, col = "#808080", lty = 3, lwd = 1.5) # Add points points(mle_profile[1], mle_profile[2], pch = 19, col = "#8B0000", cex = 1.5) points(2.5, 3.5, pch = 17, col = "#006400", cex = 1.5) legend("topright", legend = c("MLE", "True", "Joint 95% CR", "Marginal 95% CI"), col = c("#8B0000", "#006400", "#2E4057", "#808080"), pch = c(19, 17, NA, NA), lty = c(NA, NA, 1, 3), lwd = c(NA, NA, 2, 1.5), bty = "n" ) grid(col = "gray90") ## ----performance, eval=FALSE-------------------------------------------------- # # Generate large dataset # n_large <- 10000 # data_large <- rkw(n_large, 2, 3) # # # Compare timings # system.time({ # manual_ll <- -sum(log(dkw(data_large, 2, 3))) # }) # # system.time({ # cpp_ll <- llkw(c(2, 3), data_large) # }) # # # Typical results: C++ is 10-50× faster ## ----application-------------------------------------------------------------- # Simulate customer conversion rates set.seed(999) n_customers <- 800 # Generate conversion rates from EKw distribution conversion_rates <- rekw(n_customers, alpha = 1.8, beta = 2.5, lambda = 1.3) # Fit model fit_app <- optim( par = c(1.5, 2, 1), fn = llekw, gr = grekw, data = conversion_rates, method = "BFGS", hessian = TRUE ) mle_app <- fit_app$par names(mle_app) <- c("alpha", "beta", "lambda") # Summary statistics cat("Sample Summary:\n") cat("Mean:", mean(conversion_rates), "\n") cat("Median:", median(conversion_rates), "\n") cat("SD:", sd(conversion_rates), "\n\n") cat("Model Estimates:\n") print(round(mle_app, 3)) ## ----app_plot, fig.height=5, fig.width=7-------------------------------------- # Visualization x_app <- seq(0.001, 0.999, length.out = 200) fitted_app <- dekw(x_app, mle_app[1], mle_app[2], mle_app[3]) hist(conversion_rates, breaks = 30, probability = TRUE, col = "lightblue", border = "white", main = "Customer Conversion Rates", xlab = "Conversion Rate", ylab = "Density", las = 1 ) lines(x_app, fitted_app, col = "#8B0000", lwd = 2) legend("topright", legend = c("Observed", "EKw Fit"), col = c("lightblue", "#8B0000"), lwd = c(8, 2), bty = "n" ) grid(col = "gray90") ## ----session_info------------------------------------------------------------- sessionInfo()