Title: | Simulation of Legal Exemption System for European Cartel Law |
---|---|
Description: | Monte Carlo simulations of a game-theoretic model for the legal exemption system of the European cartel law are implemented in order to estimate the (mean) deterrent effect of this system. The input and output parameters of the simulated cartel opportunities can be visualized by three-dimensional projections. A description of the model is given in Moritz et al. (2018) <doi:10.1515/bejeap-2017-0235>. |
Authors: | Martin Becker [aut, cre] |
Maintainer: | Martin Becker <[email protected]> |
License: | GPL (>= 2) |
Version: | 1.0.3 |
Built: | 2025-01-06 03:16:29 UTC |
Source: | https://github.com/cran/SimEUCartelLaw |
aggResults
aggregates the results of LEgame
.
aggResults(res)
aggResults(res)
res |
dataframe containing results of simulation using |
aggResults
aggregates the results of LEgame
to a matrix
containing information about the fractions for the potential equilibria as
well as the means and standard deviations of the error probabilities, the
compliance level, and the expected illegal gains.
A matrix containing the aggregated results.
Par <- list(Phi=c(0.1,0.5), Rho=c(0.5,0.9), Ksi=c(0.05,0.3), Chi=c(0.1,0.4), M=c(0.2,1.2), G=c(0.05,0.2), A=c(0.1,0.3)) res <- LEgame(params=Par, m=100000) print(aggResults(res))
Par <- list(Phi=c(0.1,0.5), Rho=c(0.5,0.9), Ksi=c(0.05,0.3), Chi=c(0.1,0.4), M=c(0.2,1.2), G=c(0.05,0.2), A=c(0.1,0.3)) res <- LEgame(params=Par, m=100000) print(aggResults(res))
corrStruct
contains the correlation structure of the input parameters.
corrStruct
corrStruct
An object of class matrix
with 7 rows and 7 columns.
corrStruct
contains the correlation structure of the input parameters.
The actual correlation matrix used in the simulation is calculated as the
corresponding identity maxtrix + r times this matrix.
CorrStudy
investigates the effect of correlated input parameters
CorrStudy(params, m = 1e+05, rho = seq(0.1, 0.9, by = 0.2), QMC = FALSE, seed = 1)
CorrStudy(params, m = 1e+05, rho = seq(0.1, 0.9, by = 0.2), QMC = FALSE, seed = 1)
params |
named list containing numeric vectors Phi, Rho, Chi, Ksi, M, G and A with the ranges for the input parameters. |
m |
numeric scalar containing the number of Monte Carlo
replications (for each correlation intensity). Defaults to |
rho |
a numeric vector containing correlation intensities. Defaults to
|
QMC |
logical scalar. If |
seed |
numeric scalar containing the random seed for each
simulation. Defaults to |
CorrStudy
performs repeated simulations via LEgame
with
different values for the correlation intensity in order to illustrate
the effect of correlation on the deterrent effect of the legal exemption
system.
A matrix containing the results of the repeated simulations.
Par <- list(Phi=c(0.1,0.5), Rho=c(0.5,0.9), Ksi=c(0.05,0.3), Chi=c(0.1,0.4), M=c(0.2,1.2), G=c(0.05,0.2), A=c(0.1,0.3)) res <- CorrStudy(params=Par, m=10000) print(res)
Par <- list(Phi=c(0.1,0.5), Rho=c(0.5,0.9), Ksi=c(0.05,0.3), Chi=c(0.1,0.4), M=c(0.2,1.2), G=c(0.05,0.2), A=c(0.1,0.3)) res <- CorrStudy(params=Par, m=10000) print(res)
CorrStudySplit
investigates the effect of correlated input parameters
and its dependence on the illegal gain A
.
CorrStudySplit(params, m = 1e+05, rho = seq(0.1, 0.9, by = 0.2), breaks = seq(0.1, 0.3, by = 0.04), QMC = FALSE, seed = 1)
CorrStudySplit(params, m = 1e+05, rho = seq(0.1, 0.9, by = 0.2), breaks = seq(0.1, 0.3, by = 0.04), QMC = FALSE, seed = 1)
params |
named list containing numeric vectors Phi, Rho, Chi, Ksi, M, G and A with the ranges for the input parameters. |
m |
numeric scalar containing the number of Monte Carlo
replications (for each correlation intensity). Defaults to |
rho |
a numeric vector containing correlation intensities. Defaults to
|
breaks |
a numeric vector with breaks for the construction of the
intervals for the illegal gain |
QMC |
logical scalar. If |
seed |
numeric scalar containing the random seed for each
simulation. Defaults to |
CorrStudySplit
performs repeated simulations via LEgame
with
different values for the correlation intensity and reports results for
compliance and expected illegal gain for various subsets of simulated
illegal gains A
in order to further illustrate the effect of
correlation on the deterrent effect of the legal exemption system.
A matrix containing the results of the repeated simulations.
Par <- list(Phi=c(0.1,0.5), Rho=c(0.5,0.9), Ksi=c(0.05,0.3), Chi=c(0.1,0.4), M=c(0.2,1.2), G=c(0.05,0.2), A=c(0.1,0.3)) res <- CorrStudySplit(params=Par, m=10000) print(res)
Par <- list(Phi=c(0.1,0.5), Rho=c(0.5,0.9), Ksi=c(0.05,0.3), Chi=c(0.1,0.4), M=c(0.2,1.2), G=c(0.05,0.2), A=c(0.1,0.3)) res <- CorrStudySplit(params=Par, m=10000) print(res)
LEgame
simulates the legal exemption game.
LEgame(params, m = 1e+05, corrMat = diag(7), QMC = FALSE, seed = 1)
LEgame(params, m = 1e+05, corrMat = diag(7), QMC = FALSE, seed = 1)
params |
named list containing numeric vectors Phi, Rho, Chi, Ksi, M, G and A with the ranges for the input parameters. |
m |
numeric scalar containing the number of Monte Carlo
replications. Defaults to |
corrMat |
matrix containing the correlation matrix for the simulation. Defaults to a 7x7 identity matrix. |
QMC |
logical scalar. If |
seed |
numeric scalar containing the random seed for the
simulation. Defaults to |
LEgame
simulates the deterrent effect of the European cartel law
based on a game-theoretic model for the legal exemption system.
A dataframe containing the realized output of the simulation.
Par <- list(Phi=c(0.1,0.5), Rho=c(0.5,0.9), Ksi=c(0.05,0.3), Chi=c(0.1,0.4), M=c(0.2,1.2), G=c(0.05,0.2), A=c(0.1,0.3)) res <- LEgame(params=Par, m=100000) print(aggResults(res))
Par <- list(Phi=c(0.1,0.5), Rho=c(0.5,0.9), Ksi=c(0.05,0.3), Chi=c(0.1,0.4), M=c(0.2,1.2), G=c(0.05,0.2), A=c(0.1,0.3)) res <- LEgame(params=Par, m=100000) print(aggResults(res))
NoRglPlot
visualizes the results of the simulation of the legal
exemption system using 3D-projections and corresponding 3D-plots.
NoRglPlot(res, xvar = "rA", yvar = "rM", zvar = "c", xf = 1, yf = 1, zf = 1, pch = 16, phi = 20, theta = -30, d = 2)
NoRglPlot(res, xvar = "rA", yvar = "rM", zvar = "c", xf = 1, yf = 1, zf = 1, pch = 16, phi = 20, theta = -30, d = 2)
res |
dataframe containing results of simulation using |
xvar |
character scalar containing variable for the x-axis.
Defaults to |
yvar |
character scalar containing variable for the y-axis.
Defaults to |
zvar |
character scalar containing variable for the z-axis.
Defaults to |
xf |
numeric scalar containing scaling constant for the x-axis. Defaults
to |
yf |
numeric scalar containing scaling constant for the y-axis. Defaults
to |
zf |
numeric scalar containing scaling constant for the z-axis. Defaults
to |
pch |
numeric or character scalar containing the plot character used
for the individual points. Defaults to |
phi |
numeric scalar containing the phi angle (colatitude)
for the perspective in degrees. Defaults to |
theta |
numeric scalar containing the theta angle (azimuthal direction)
for the perspective in degrees. Defaults to |
d |
numeric scalar for the strenth of the perspective effect.
Defaults to |
NoRglPlot
visualizes the results of the simulation of the legal
exemption system using 3D-projections and corresponding plots without
using rgl
/GL
.
Nothing useful, function called for its side effects.
Par <- list(Phi=c(0.1,0.5), Rho=c(0.5,0.9), Ksi=c(0.05,0.3), Chi=c(0.1,0.4), M=c(0.2,1.2), G=c(0.05,0.2), A=c(0.1,0.3)) NoRglPlot(LEgame(params=Par, m=10000))
Par <- list(Phi=c(0.1,0.5), Rho=c(0.5,0.9), Ksi=c(0.05,0.3), Chi=c(0.1,0.4), M=c(0.2,1.2), G=c(0.05,0.2), A=c(0.1,0.3)) NoRglPlot(LEgame(params=Par, m=10000))
SimEUCartelLaw implements simulation methods for the legal exemption system fot the European cartel law.
SimEUCartelLaw implements Monte Carlo simulations of a game-theoretic model for the legal exemption system of the European cartel in order to estimate the (mean) deterrent effect of this system. The input and output parameters of the simulated cartel opportunities can be visualized by three-dimensional projections.
Par <- list(Phi=c(0.1,0.5), Rho=c(0.5,0.9), Ksi=c(0.05,0.3), Chi=c(0.1,0.4), M=c(0.2,1.2), G=c(0.05,0.2), A=c(0.1,0.3)) res <- LEgame(params=Par,m=100000) print(aggResults(res)) print(CorrStudy(params=Par, m=10000)) print(CorrStudySplit(params=Par, m=10000)) NoRglPlot(LEgame(params=Par, m=10000))
Par <- list(Phi=c(0.1,0.5), Rho=c(0.5,0.9), Ksi=c(0.05,0.3), Chi=c(0.1,0.4), M=c(0.2,1.2), G=c(0.05,0.2), A=c(0.1,0.3)) res <- LEgame(params=Par,m=100000) print(aggResults(res)) print(CorrStudy(params=Par, m=10000)) print(CorrStudySplit(params=Par, m=10000)) NoRglPlot(LEgame(params=Par, m=10000))