Navigation

    Voting Theory Forum

    • Register
    • Login
    • Search
    • Recent
    • Categories
    • Tags
    • Popular
    • Users
    • Groups
    1. Home
    2. cfrank
    3. Posts
    C
    • Profile
    • Following 1
    • Followers 3
    • Topics 61
    • Posts 460
    • Best 97
    • Groups 2

    Posts made by cfrank

    • RE: Idea for truly proportional representation

      @toby-pereira I agree with this. Something in that spirit I am considering is that the power allocations can still be traced back to ballots. For example, if the seated representatives and powers were {A:45, B:35, C:20}, in principle, those single seats could be subdivided into multiple seats of roughly equal power, depending on the candidate pool (i.e. how many candidates are available).

      Possibly, a sub-election could be run to determine the representatives within the A:45 group, etc. Maybe they could be given 4 seats, the B:35 group 3 seats, and C:20 2 seats. That could refine representation, some candidates might pick up multiple seats. It’s probably getting messy and complicated, it essentially becomes a hierarchical partitioning of ballots. I’m not sure what to make of that prospect, it starts looking like a network/phylogenetic tree or forest architecture, and that can become arbitrary fast.

      I do see what you mean. An individual voter may actually prefer a particular coalition of candidates, rather than just want to get their top guy in. I wonder if non-strict rankings and distributed power would mitigate this issue, or for instance, if the A:45 group's sub-election guaranteed a seat for A, and ran the election on the remaining candidates, that might align with the spirit of preference for whole coalitions.

      You definitely are more familiar with this space than I am, so I wager some of my objections may be non-issues when one considers alternative PR methods. But it seems to me that in this case, pushing for coalitions that respect single individual preferences for whole coalitions can lean toward reduced diversity and reduced minority representation. Is that inaccurate? Or is that a common tradeoff issue in PR systems?

      “Would the weighting purely count towards their voting power in the elected body, or does it have other effects such as more time to speak?”

      Yeah, it does beg some questions.

      EDIT: After multiple adjustments made to guard against clone dependence and tactical voting, there is a non-monotonicity issue in my latest version (/branch, it is not my original concept so I don’t claim ownership in any way), where a minority faction can gain strictly preferred representation in the form of a seated candidate by merely withholding approval for that candidate. I have a concrete example of this, and may try to see how to address it. It may be due to something unnecessary.

      posted in Voting Theoretic Criteria
      C
      cfrank
    • RE: Idea for truly proportional representation

      @toby-pereira Awesome! I also reached out to the original author and linked them here.
      I hashed out more adjustments and a Python code chunk that runs elections with detailed audits. It's a bit sophisticated... and currently it actually removes 0-power seats rather than keeping them as a ceremonial role, probably they should still be seated in case subsequent power adjustments are computed. But the latest version and some examples are below.

      The description is not very straightforward either, but the results look pretty good to me.

      """
      Median-T Satiation with Dynamic Prefix Tightening + Candidate-wise RUS
      Exact implementation of the specified method with detailed auditing
      
      METHOD SPECIFICATION:
      ====================
      1. Ballots: RAC (Rank with Approval Cutoff) - each voter ranks all candidates and approves top a_i
      2. T = median(a_i) computed once at start (upper median if even)
      3. Fill seats K=1 to N iteratively
      4. DYNAMIC PREFIX TIGHTENING: Once satiated, a voter's active approvals are always 
         the prefix up to their CURRENT top-ranked seated winner. As better candidates 
         are seated, the prefix tightens upward. It never loosens.
      5. CANDIDATE-WISE RUS: Identify specific "consensus triggers" (candidates that would
         satiate ALL remaining voters). Mark only those candidates as non-satiating, but
         allow satiation based on other winners in the set.
      6. TIEBREAK PRIORITY: Prefer non-flagged candidates over RUS-flagged ones when breaking ties.
      """
      
      from dataclasses import dataclass, field
      from typing import List, Dict, Tuple, Set, Optional
      import math
      import pandas as pd
      from collections import defaultdict
      import copy
      
      class AuditLog:
          """Detailed logging of each step in the process"""
          def __init__(self, verbose: bool = True):
              self.entries = []
              self.verbose = verbose
          
          def log(self, phase: str, rule: str, details: str, data: dict = None):
              entry = {
                  "phase": phase,
                  "rule": rule,
                  "details": details,
                  "data": data or {}
              }
              self.entries.append(entry)
              if self.verbose:
                  print(f"[{phase}] {rule}")
                  print(f"  → {details}")
                  if data:
                      for k, v in data.items():
                          print(f"    {k}: {v}")
                  print()
      
      @dataclass
      class VoterGroup:
          """Represents a group of voters with identical preferences"""
          n: int                          # Number of voters in group
          rank: List[str]                 # Strict ranking of all candidates
          a: int                          # Approval cutoff (approve top a candidates)
          saturated: bool = False         # Whether group is saturated
          satiation_prefix_end: Optional[str] = None  # H: highest-ranked winner when satiated
          
          def get_prefix_candidates(self) -> Set[str]:
              """
              Get candidates in the satiation prefix (at or above H in ranking)
              """
              if not self.saturated or not self.satiation_prefix_end:
                  return set(self.rank)  # All candidates if not saturated
              
              prefix = set()
              for c in self.rank:
                  prefix.add(c)
                  if c == self.satiation_prefix_end:
                      break
              return prefix
          
          def active_approvals(self, current_winners: List[str] = None) -> Set[str]:
              """
              RULE: Active Approvals with Dynamic Prefix Tightening
              - Unsaturated: approve top a_i candidates
              - Saturated: approve only candidates in prefix up to CURRENT top-ranked winner
              """
              if not self.saturated:
                  return set(self.rank[:self.a])
              
              # Saturated: dynamically compute H based on current winners
              if current_winners:
                  current_H = self.top_in_set(current_winners)
                  if current_H:
                      # Build prefix up to current H
                      prefix = set()
                      for c in self.rank:
                          prefix.add(c)
                          if c == current_H:
                              break
                      original_approvals = set(self.rank[:self.a])
                      return original_approvals & prefix
              
              # Fallback to stored prefix
              prefix = self.get_prefix_candidates()
              original_approvals = set(self.rank[:self.a])
              return original_approvals & prefix
          
          def can_influence_h2h(self, cand_a: str, cand_b: str, current_winners: List[str] = None) -> bool:
              """
              RULE: Active Ranking Influence with Dynamic Prefix
              - Unsaturated: can influence all head-to-heads
              - Saturated: can only influence if BOTH candidates are in dynamically computed prefix
              """
              if not self.saturated:
                  return True
              
              # Compute current prefix based on current winners
              if current_winners:
                  current_H = self.top_in_set(current_winners)
                  if current_H:
                      # Build prefix up to current H
                      prefix = set()
                      for c in self.rank:
                          prefix.add(c)
                          if c == current_H:
                              break
                      return cand_a in prefix and cand_b in prefix
              
              # Fallback to stored prefix
              prefix = self.get_prefix_candidates()
              return cand_a in prefix and cand_b in prefix
          
          def prefers(self, a: str, b: str, current_winners: List[str] = None) -> int:
              """
              Return 1 if a>b, -1 if b>a, 0 if tie
              Only valid if can_influence_h2h returns True
              """
              if not self.can_influence_h2h(a, b, current_winners):
                  return 0  # No influence
              
              pos = {c: i for i, c in enumerate(self.rank)}
              ia, ib = pos.get(a, math.inf), pos.get(b, math.inf)
              if ia < ib: return 1
              if ib < ia: return -1
              return 0
          
          def top_in_set(self, winners: List[str]) -> Optional[str]:
              """
              Return highest-ranked candidate from winners (H for this voter)
              """
              for c in self.rank:
                  if c in winners:
                      return c
              return None
          
          def get_rank_position(self, candidate: str) -> int:
              """Get 0-based position of candidate in ranking"""
              try:
                  return self.rank.index(candidate)
              except ValueError:
                  return math.inf
          
          def would_satiate(self, winners: List[str], T: int) -> bool:
              """
              RULE: Satiation Test
              Voter satiates if ANY winner appears within top min(T, a_i) ranks
              """
              if self.saturated:
                  return False
              
              threshold = min(T, self.a)
              for w in winners:
                  pos = self.get_rank_position(w)
                  if pos < threshold:
                      return True
              return False
      
      @dataclass
      class Election:
          """Manages the election process with detailed auditing"""
          candidates: List[str]
          groups: List[VoterGroup]
          tie_order: List[str] = field(default_factory=list)
          audit: AuditLog = field(default_factory=AuditLog)
          
          def __post_init__(self):
              if not self.tie_order:
                  self.tie_order = list(self.candidates)
              self.T = None  # Will be computed once
          
          def compute_T(self) -> int:
              """
              RULE: T Calculation
              T = median of all approval cutoffs (upper median if even)
              Computed ONCE at the start, stays fixed
              """
              if self.T is not None:
                  return self.T
                  
              a_list = []
              for g in self.groups:
                  a_list.extend([g.a] * g.n)  # Expand by voter count
              a_list.sort()
              
              m = len(a_list)
              if m == 0:
                  self.T = 0
              elif m % 2 == 1:
                  self.T = a_list[m//2]
              else:
                  self.T = a_list[m//2]  # Upper median for even
              
              self.audit.log(
                  "INITIALIZATION", 
                  "T Calculation (Median of Approval Cutoffs)",
                  f"Median of {m} voters' approval cutoffs = {self.T}",
                  {"all_cutoffs": a_list, "T": self.T}
              )
              return self.T
          
          def tally_active_approvals(self, current_winners: List[str] = None) -> Dict[str, int]:
              """
              RULE: Approval Tallying with Dynamic Prefix Tightening
              Count active approvals from all groups (with dynamic H adjustment for satiated voters)
              """
              tallies = {c: 0 for c in self.candidates}
              
              for i, g in enumerate(self.groups):
                  approved = g.active_approvals(current_winners)
                  for c in approved:
                      if c in self.candidates:  # Only count if still in race
                          tallies[c] += g.n
              
              # Only return tallies for current candidates
              return {c: tallies[c] for c in self.candidates}
          
          def head_to_head(self, a: str, b: str, current_winners: List[str] = None) -> int:
              """
              RULE: Head-to-Head Tiebreaking with Dynamic Prefix
              Use rankings from voters who can influence this comparison
              """
              a_score = b_score = 0
              
              for g in self.groups:
                  pref = g.prefers(a, b, current_winners)
                  if pref > 0:
                      a_score += g.n
                  elif pref < 0:
                      b_score += g.n
              
              if a_score > b_score: return 1
              if b_score > a_score: return -1
              return 0
          
          def select_provisional_winners(self, K: int, iteration: int, previous_winners: List[str] = None, 
                                         non_satiating_candidates: Set[str] = None) -> List[str]:
              """
              RULE: Pick Provisional Winners
              1. Tally active approvals (based on previous winners for dynamic prefix)
              2. Take top K by approval count
              3. Tiebreak: prioritize non-flagged over RUS-flagged, then head-to-head, then fixed order
              """
              if non_satiating_candidates is None:
                  non_satiating_candidates = set()
                  
              tallies = self.tally_active_approvals(previous_winners)
              
              self.audit.log(
                  f"K={K} ITER-{iteration}",
                  "Active Approval Tally",
                  f"Current approval counts (with previous winners: {previous_winners})",
                  {"tallies": tallies, "non_satiating": list(non_satiating_candidates)}
              )
              
              # Group by approval count
              by_tally = defaultdict(list)
              for c, t in tallies.items():
                  by_tally[t].append(c)
              
              # Sort tallies descending
              sorted_candidates = []
              for tally in sorted(by_tally.keys(), reverse=True):
                  tied = by_tally[tally]
                  
                  if len(tied) == 1:
                      sorted_candidates.extend(tied)
                  else:
                      # Tiebreak needed
                      self.audit.log(
                          f"K={K} ITER-{iteration}",
                          "Tiebreaking",
                          f"{len(tied)} candidates tied with {tally} approvals",
                          {"tied_candidates": tied}
                      )
                      
                      # Sort by: (1) non-flagged before flagged, (2) head-to-head wins, (3) fixed order
                      def tiebreak_key(cand):
                          is_flagged = 1 if cand in non_satiating_candidates else 0
                          wins = sum(1 for other in tied if other != cand and self.head_to_head(cand, other, previous_winners) > 0)
                          return (is_flagged, -wins, self.tie_order.index(cand))
                      
                      tied_sorted = sorted(tied, key=tiebreak_key)
                      sorted_candidates.extend(tied_sorted)
              
              winners = sorted_candidates[:K]
              self.audit.log(
                  f"K={K} ITER-{iteration}",
                  "Provisional Winners Selected",
                  f"Top {K} candidates by approval with tiebreaking",
                  {"winners": winners}
              )
              
              return winners
          
          def apply_satiation(self, winners: List[str], T: int, non_satiating_candidates: Set[str]) -> Tuple[List[int], Set[str]]:
              """
              RULE: Median-T Satiation with Candidate-wise RUS
              Returns (list of newly satiated group indices, set of consensus triggers identified)
              """
              # First, identify consensus triggers (candidates that would satiate ALL unsaturated voters)
              # Skip candidates already flagged as non-satiating
              unsaturated_groups = [g for g in self.groups if not g.saturated]
              consensus_triggers = set()
              
              if unsaturated_groups:
                  # Check each winner to see if it's a consensus trigger
                  for w in winners:
                      # Skip already-flagged candidates
                      if w in non_satiating_candidates:
                          continue
                          
                      is_consensus = True
                      for g in unsaturated_groups:
                          pos = g.get_rank_position(w)
                          threshold = min(T, g.a)
                          if pos >= threshold:  # This candidate doesn't trigger this voter
                              is_consensus = False
                              break
                      if is_consensus:
                          consensus_triggers.add(w)
                  
                  if consensus_triggers:
                      self.audit.log(
                          f"K={len(winners)}",
                          "New Consensus Triggers Identified",
                          f"Candidates {consensus_triggers} would satiate ALL remaining voters",
                          {"consensus_triggers": list(consensus_triggers)}
                      )
              
              # Now apply satiation, but ignore consensus triggers as satiation causes
              newly_satiated = []
              
              for gi, g in enumerate(self.groups):
                  if g.saturated:
                      continue
                      
                  # Find highest-ranked winner that's NOT a consensus trigger or already non-satiating
                  ignore_for_satiation = consensus_triggers | non_satiating_candidates
                  
                  # Check if this voter would satiate based on non-ignored winners
                  threshold = min(T, g.a)
                  for w in winners:
                      if w in ignore_for_satiation:
                          continue
                      pos = g.get_rank_position(w)
                      if pos < threshold:
                          # This voter satiates based on winner w
                          H = g.top_in_set(winners)  # Still use actual top winner for prefix
                          g.saturated = True
                          g.satiation_prefix_end = H
                          newly_satiated.append(gi)
                          
                          prefix = g.get_prefix_candidates()
                          self.audit.log(
                              f"K={len(winners)}",
                              f"Group {gi+1} Satiated",
                              f"H={H}, satiated via {w}, retaining prefix of {len(prefix)} candidates",
                              {"group_size": g.n, "H": H, "trigger": w, "prefix": list(prefix)}
                          )
                          break
              
              return newly_satiated, consensus_triggers
          
          def assign_power(self, winners: List[str]) -> Dict[str, int]:
              """
              RULE: Power Assignment
              Each voter assigns power to their highest-ranked winner
              """
              power = {w: 0 for w in winners}
              
              for g in self.groups:
                  rep = g.top_in_set(winners)
                  if rep:
                      power[rep] += g.n
              
              return power
          
          def eliminate_zero_power(self, winners: List[str], power: Dict[str, int]) -> List[str]:
              """
              RULE: Zero-Power Elimination
              Remove winners with no voter support
              """
              eliminated = [w for w in winners if power[w] == 0]
              
              if eliminated:
                  self.audit.log(
                      f"K={len(winners)}",
                      "Zero-Power Elimination",
                      f"Removing {len(eliminated)} candidates with no support",
                      {"eliminated": eliminated}
                  )
                  
                  # Remove from candidate list
                  self.candidates = [c for c in self.candidates if c not in eliminated]
                  self.tie_order = [c for c in self.tie_order if c in self.candidates]
                  
                  # Update satiation prefixes if needed
                  for g in self.groups:
                      if g.satiation_prefix_end in eliminated:
                          # Find next candidate in prefix that's still valid
                          prefix_cands = []
                          for c in g.rank:
                              if c in self.candidates:
                                  prefix_cands.append(c)
                              if c == g.satiation_prefix_end:
                                  break
                          
                          # Update H to last valid candidate in prefix, or None
                          g.satiation_prefix_end = prefix_cands[-1] if prefix_cands else None
                          if g.satiation_prefix_end is None:
                              g.saturated = False  # No valid prefix anymore
              
              return eliminated
          
          def run_for_K(self, K: int) -> Tuple[List[str], Dict[str, int]]:
              """
              Main algorithm for selecting K winners with candidate-wise RUS and dynamic prefix tightening
              """
              self.audit.log(
                  f"K={K}",
                  "Starting K-Selection",
                  f"Selecting {K} winners from {len(self.candidates)} candidates",
                  {"candidates": self.candidates[:10] if len(self.candidates) > 10 else self.candidates}
              )
              
              T = self.compute_T()
              non_satiating_candidates = set()  # Specific candidates marked as non-satiating for this K
              
              iteration = 0
              last_winners = []  # Start with empty set
              last_power = None
              max_iterations = 100
              
              while iteration < max_iterations:
                  iteration += 1
                  
                  # Step 1: Pick provisional winners based on previous winners (for dynamic prefix)
                  # and considering non-satiating candidates for tiebreaking
                  winners = self.select_provisional_winners(K, iteration, 
                                                           last_winners if iteration > 1 else None,
                                                           non_satiating_candidates)
                  
                  # Step 2: Apply satiation with candidate-wise RUS
                  newly_satiated, found_consensus_triggers = self.apply_satiation(winners, T, non_satiating_candidates)
                  
                  # Compute newly added consensus triggers (not already known)
                  newly_added_triggers = found_consensus_triggers - non_satiating_candidates
                  
                  # Add newly identified consensus triggers to non-satiating set
                  if newly_added_triggers:
                      non_satiating_candidates.update(newly_added_triggers)
                      self.audit.log(
                          f"K={K} ITER-{iteration}",
                          "Non-satiating Candidates Updated",
                          f"Added {newly_added_triggers} to non-satiating set",
                          {"newly_added": list(newly_added_triggers), 
                           "total_non_satiating": list(non_satiating_candidates)}
                      )
                  
                  # Step 3: Assign power
                  power = self.assign_power(winners)
                  self.audit.log(
                      f"K={K} ITER-{iteration}",
                      "Power Assignment",
                      "Voter support distribution",
                      {"power": power}
                  )
                  
                  # Step 4: Eliminate zero-power winners
                  eliminated = self.eliminate_zero_power(winners, power)
                  
                  # Check for stabilization - only count NEWLY ADDED triggers as a change
                  changed = (winners != last_winners or 
                            power != last_power or 
                            newly_satiated or 
                            bool(newly_added_triggers) or  # Only newly added, not all found
                            eliminated)
                  
                  if not changed:
                      self.audit.log(
                          f"K={K}",
                          "STABILIZED",
                          f"No changes in iteration {iteration}",
                          {"final_winners": winners, "final_power": power}
                      )
                      break
                  
                  last_winners = winners
                  last_power = power
              
              return winners, power
      
      def run_election_with_audit(title: str, candidates: List[str], groups: List[VoterGroup], 
                                 max_K: int, verbose: bool = True):
          """
          Run complete election from K=1 to max_K with detailed auditing
          """
          print("="*80)
          print(f"ELECTION: {title}")
          print("="*80)
          
          if verbose:
              print("\nINITIAL CONFIGURATION:")
              print(f"Candidates: {candidates}")
              print("\nVoter Groups:")
              for i, g in enumerate(groups):
                  print(f"  Group {i+1}: {g.n} voters")
                  print(f"    Ranking: {' > '.join(g.rank)}")
                  print(f"    Approves top {g.a}: {list(g.rank[:g.a])}")
              print()
          
          # Create fresh election (groups will carry satiation forward between K values)
          el = Election(
              candidates=list(candidates),
              groups=groups,  # These will maintain state across K
              tie_order=list(candidates),
              audit=AuditLog(verbose=verbose)
          )
          
          results = []
          for K in range(1, max_K + 1):
              if verbose:
                  print(f"\n{'='*60}")
                  print(f"SOLVING FOR K={K}")
                  print(f"{'='*60}\n")
              
              winners, power = el.run_for_K(K)
              
              results.append({
                  "K": K,
                  "Winners": winners,
                  "Power": power,
                  "Power_str": ", ".join(f"{w}:{p}" for w, p in power.items())
              })
              
              if verbose:
                  print(f"\nRESULT FOR K={K}:")
                  print(f"  Winners: {winners}")
                  print(f"  Power: {power}")
          
          return results
      
      # Example scenarios
      def demo_scenario():
          """Run a demonstration scenario"""
          resuls = None
          if True:
              # Scenario: Three factions with compromise candidate U
              candidates = ["A", "B", "C", "U", "D"]
              groups = [
                  VoterGroup(34, ["A", "U", "B", "C", "D"], 2),
                  VoterGroup(33, ["B", "U", "A", "C", "D"], 2), 
                  VoterGroup(33, ["C", "U", "A", "B", "D"], 2),
              ]
              
              results = run_election_with_audit(
                  "Three Factions with Universal Compromise",
                  candidates,
                  groups,
                  max_K=3,
                  verbose=True
              )
              
              # Summary table
              print("\n" + "="*80)
              print("SUMMARY")
              print("="*80)
              df = pd.DataFrame([{
                  "K": r["K"],
                  "Winners": ", ".join(r["Winners"]),
                  "Power Distribution": r["Power_str"]
              } for r in results])
              print(df.to_string(index=False))
          elif True:
              pass
          
          return results
      
      if __name__ == "__main__":
          demo_scenario()
      
      # -------------------------------
      # More example elections
      # -------------------------------
      
      def scenario_majority_clones_vs_two_minorities(verbose=False):
          """
          Majority (52) spreads support across 3 near-clone heads (A1,A2,A3).
          Two cohesive minorities (28 for B-first, 20 for C-first).
          Stress: clone-packing + whether minorities still seat as K grows.
          Expectation: As K increases, A-bloc locks to one/two A* winners,
          while B and C each capture representation; U (none here) not present.
          """
          candidates = ["A1","A2","A3","B","C","D"]
          groups = [
              VoterGroup(18, ["A1","A2","A3","B","C","D"], 3),
              VoterGroup(17, ["A2","A3","A1","B","C","D"], 3),
              VoterGroup(17, ["A3","A1","A2","B","C","D"], 3),
              VoterGroup(28, ["B","C","A1","A2","A3","D"], 2),
              VoterGroup(20, ["C","B","A1","A2","A3","D"], 2),
          ]
          return run_election_with_audit(
              "Majority Clones vs Two Minorities",
              candidates, groups, max_K=4, verbose=verbose
          )
      
      def scenario_heterogeneous_T(verbose=False):
          """
          Heterogeneous approval cutoffs so median-T matters.
          30 voters approve only top-1; 30 approve top-2; 40 approve top-3.
          Expectation: T=2 (upper median). Compromise M is high but not always seated
          unless supported by multiple blocs; dynamic tightening should peel off approvals.
          """
          candidates = ["A","B","C","M","D","E"]
          groups = [
              VoterGroup(30, ["A","M","B","C","D","E"], 1),
              VoterGroup(30, ["B","M","A","C","D","E"], 2),
              VoterGroup(40, ["C","M","B","A","D","E"], 3),
          ]
          return run_election_with_audit(
              "Heterogeneous T (1/2/3) with Compromise M",
              candidates, groups, max_K=3, verbose=verbose
          )
      
      def scenario_big_majority_plus_consensus_U(verbose=False):
          """
          Big majority (60) vs minority (40), with widely approved compromise U.
          Approvals: Majority approves {A, U}; Minority approves {B, U}.
          Expectation: K=1 likely U; as K grows, blocs lock to A and B and U falls back.
          """
          candidates = ["A","B","U","C","D"]
          groups = [
              VoterGroup(60, ["A","U","B","C","D"], 2),
              VoterGroup(40, ["B","U","A","C","D"], 2),
          ]
          return run_election_with_audit(
              "Big Majority vs Minority with Consensus U",
              candidates, groups, max_K=3, verbose=verbose
          )
      
      def scenario_two_parties_plus_centrist(verbose=False):
          """
          Two parties (45/45) with distinct heads (A,B) and a centrist M broadly approved.
          Small 10-voter group prefers a reformer R (also approves M).
          Expectation: K=1 often M; K=2/3 should seat A and B; R may or may not make it at K=3/4.
          """
          candidates = ["A","B","M","R","D"]
          groups = [
              VoterGroup(45, ["A","M","B","R","D"], 2),
              VoterGroup(45, ["B","M","A","R","D"], 2),
              VoterGroup(10, ["R","M","A","B","D"], 2),
          ]
          return run_election_with_audit(
              "Two Parties + Centrist + Reformer",
              candidates, groups, max_K=4, verbose=verbose
          )
      
      def scenario_clone_sprinkling_attempt(verbose=False):
          """
          Simulate a 'decoy sprinkling' attempt: the 55-voter bloc splits into
          three sub-blocs each ranking a different decoy D* first, all approving their real champion X as well.
          Minority prefers Y and Z. Tests candidate-wise RUS + tightening against seat-packing.
          """
          candidates = ["X","Y","Z","D1","D2","D3","W"]
          groups = [
              VoterGroup(19, ["D1","X","D2","D3","Y","Z","W"], 2),
              VoterGroup(18, ["D2","X","D3","D1","Y","Z","W"], 2),
              VoterGroup(18, ["D3","X","D1","D2","Y","Z","W"], 2),
              VoterGroup(25, ["Y","Z","X","D1","D2","D3","W"], 2),
              VoterGroup(20, ["Z","Y","X","D1","D2","D3","W"], 2),
          ]
          return run_election_with_audit(
              "Clone Sprinkling Attempt (Decoys D1–D3)",
              candidates, groups, max_K=4, verbose=verbose
          )
      
      def scenario_many_seats_party_listish(verbose=False):
          """
          Party-list-ish: A:40, B:35, C:25 with some cross-approval for a shared governance U.
          Test proportionality as K increases (K up to 5).
          """
          candidates = ["A1","A2","B1","B2","C1","U","D"]
          groups = [
              VoterGroup(40, ["A1","U","A2","B1","C1","B2","D"], 2),
              VoterGroup(35, ["B1","U","B2","A1","C1","A2","D"], 2),
              VoterGroup(25, ["C1","U","A1","B1","A2","B2","D"], 2),
          ]
          return run_election_with_audit(
              "Many Seats, Party-list-ish with Shared U",
              candidates, groups, max_K=5, verbose=verbose
          )
      
      def scenario_tie_sensitivity(verbose=False):
          """
          Tight ties across factions; tie order matters.
          Use symmetric 33/33/34 with shared approvals to force frequent ties.
          Verify your tie-break ('unflagged before flagged', then H2H, then fixed).
          """
          candidates = ["A","B","C","M","N"]
          groups = [
              VoterGroup(34, ["A","M","B","C","N"], 2),
              VoterGroup(33, ["B","M","C","A","N"], 2),
              VoterGroup(33, ["C","M","A","B","N"], 2),
          ]
          return run_election_with_audit(
              "Tie Sensitivity (Symmetric 34/33/33)",
              candidates, groups, max_K=3, verbose=verbose
          )
      
      def scenario_median_T_equals_one(verbose=False):
          """
          Force T=1: simple-majority may try to set median approval to 1.
          Everyone approves exactly one (a_i=1), different heads.
          Expectation: behaves close to STV-ish seat allocation by top ranks; 
          dynamic tightening is trivial but RUS can still mute universal names.
          """
          candidates = ["A","B","C","U","D"]
          groups = [
              VoterGroup(40, ["A","U","B","C","D"], 1),
              VoterGroup(35, ["B","U","A","C","D"], 1),
              VoterGroup(25, ["C","U","A","B","D"], 1),
          ]
          return run_election_with_audit(
              "Median T = 1 (All a_i=1)",
              candidates, groups, max_K=3, verbose=verbose
          )
      
      def run_more_examples(verbose=False):
          """
          Run all the example scenarios above.
          Set verbose=True for full step-by-step audits.
          """
          all_results = []
      
          print("\n" + "="*80)
          print("SCENARIO 1: Majority Clones vs Two Minorities")
          print("="*80)
          all_results.append(scenario_majority_clones_vs_two_minorities(verbose=verbose))
      
          print("\n" + "="*80)
          print("SCENARIO 2: Heterogeneous T (1/2/3) with Compromise M")
          print("="*80)
          all_results.append(scenario_heterogeneous_T(verbose=verbose))
      
          print("\n" + "="*80)
          print("SCENARIO 3: Big Majority vs Minority with Consensus U")
          print("="*80)
          all_results.append(scenario_big_majority_plus_consensus_U(verbose=verbose))
      
          print("\n" + "="*80)
          print("SCENARIO 4: Two Parties + Centrist + Reformer")
          print("="*80)
          all_results.append(scenario_two_parties_plus_centrist(verbose=verbose))
      
          print("\n" + "="*80)
          print("SCENARIO 5: Clone Sprinkling Attempt (Decoys D1–D3)")
          print("="*80)
          all_results.append(scenario_clone_sprinkling_attempt(verbose=verbose))
      
          print("\n" + "="*80)
          print("SCENARIO 6: Many Seats, Party-list-ish with Shared U")
          print("="*80)
          all_results.append(scenario_many_seats_party_listish(verbose=verbose))
      
          print("\n" + "="*80)
          print("SCENARIO 7: Tie Sensitivity (Symmetric 34/33/33)")
          print("="*80)
          all_results.append(scenario_tie_sensitivity(verbose=verbose))
      
          print("\n" + "="*80)
          print("SCENARIO 8: Median T = 1 (All a_i=1)")
          print("="*80)
          all_results.append(scenario_median_T_equals_one(verbose=verbose))
      
          # Print compact summaries for each scenario’s last run
          print("\n" + "="*80)
          print("SUMMARY (compact)")
          print("="*80)
          for bundle in all_results:
              # bundle is the list returned by run_election_with_audit (one dict per K)
              df = pd.DataFrame([{
                  "K": r["K"],
                  "Winners": ", ".join(r["Winners"]),
                  "Power": r["Power_str"]
              } for r in bundle])
              print(df.to_string(index=False))
              print("-"*80)
      
          return all_results
      
      
      posted in Voting Theoretic Criteria
      C
      cfrank
    • RE: Idea for truly proportional representation

      @poppeacock here is another toy example, which shows that while seating may be pluralistic/consensus based, the ultimate power-based representation may be strongly majoritarian.

      Example: A “universally approved” compromise seat has ~0 power.

      N = 3 seats, 5 candidates, 100 voters
      • 40: A > M | B C D (approve {A,M})
      • 35: B > M | A C D (approve {B,M})
      • 25: C > B > M > A | D (approve {C,B,M,A})

      Approvals: M=100, A=65, B=60, C=25 → Seated: {M, A, B}.
      Strength:
      • 40 A-first → A
      • 35 B-first → B
      • 25 C-first → among seated {M,A,B} they rank B > M > A → B
      Final: A=40, B=60, M=0.

      The only universally approved candidate M is seated, but powerless, and the majority coalition has monopolized all legitimate majority-based bargaining power through representative B.

      Maybe that’s OK with so few seats? I’m just trying to think through the implications of the system. My guess is that this same kind of power-based majoritarianism may still cause issues even with more seats available. I could be wrong.

      However, it’s important to note that the proportionality/plurality/consensus aspect hinges strongly and primarily on the seating method. Using approval, for example, makes the seats susceptible to strategic nomination of clones, where a majority faction could dominate all seats by approving many clone candidates.

      So the method would need to rely on other more specialized PR-based seating algorithms. In that case, the majoritarian power allocation aspect becomes a questionable design choice, since it seems to potentially undermine the very pluralism that the PR-based seating is meant to achieve.

      The majoritarianism becomes less of an issue though if decisions require supermajorities of power (as it always does).

      SUGGESTED PRELIMINARY ADJUSTMENTS:

      This is out of my wheelhouse, but possibly this could be addressed by removing candidates with zero power, and enabling runners-up to take their seats. And in the approval case, perhaps also allocating approval to the top-seated candidate. This is a suggested direction for using approval:

      1. Select provisional open seat allocations by approval. If there are approval ties, resolve them by a head-to-head match if possible, otherwise by a predetermined sort order of the candidates.
      2. If any voter has their top-ranked candidate provisionally seated, remove all other approval support they give to other candidates, and discount any rankings from their ballot in subsequent head-to-head matches. Allocate provisional power.
      3. If there are any filled seats with zero power, completely remove the provisionally seated candidates with zero power from the election and vacate their seats.
      4. Repeat from step (1) using the updated approval and ranking profiles, until there is no change in the seating or power allocation.

      EDIT: There is a serious issue that remains with using approval even after the adjustments above: A majority could still crowd out seats by coordinating multiple “threads” of ballot with each clone as the head of the thread. It seems that the seating algorithm needs to be something different from straight approval.

      Here’s a thought though—what if the approval seating process was performed with an increasing seat number schedule? So for example, first, there is only one seat, then the election iterates until stability. Then, there are two seats, etc. This would disallow the vulnerability we just discovered, I believe, because the voters whose first choice got represented could no longer contribute to bloc approvals.

      I tested this version out, and it does pretty well.

      UPDATED SUGGESTIONS FOR ADJUSTMENT:

      I assume that we would want to use an approval-based mechanism to determine the seat allocations.

      First, if the total number of seats is N, then to avoid majoritarian seat-packing by bloc approval, rather than a single seat allocation of all seats at once, there should be a sequence of elections for K seats, where K is initialized at 1 and increases incrementally to N.

      The other rules would be as follows:

      1. Select provisional open seat allocations by approval. If there are approval ties, resolve them by a head-to-head match if possible, otherwise by a predetermined sort order of the candidates.
      2. If any voter has their top-ranked candidate provisionally seated, remove all other approval support they give to other candidates, and discount any rankings from their ballot in subsequent head-to-head matches. Allocate provisional power according to your rule (top-ranked seated candidate).
      3. If there are any filled seats with zero power, completely remove the provisionally seated candidates with zero power from the election and vacate their seats.
      4. Repeat from step (1) using the updated approval and ranking profiles, until there is no change in the seating or power allocation.

      This iteration will stabilize the seating for the value of K. Afterwards, proceed by increasing K by 1, maintaining the changes to the ballots that were incurred sequentially (ex: as in step (2), where some approvals and rankings are disregarded), and stopping after stabilization for K=N.

      The "top-rank satiation" principle of ("has their top-ranked candidate provisionally seated") is something that can be exploited by sprinkling in decoy candidates as top-ranks. It requires a pool of many distinct decoys and coordination, but is possible. An alternative is to satiate a voter when any of their approved candidates is seated, but that may "over-satiate" voters. Or, voters could indicate their own satiation thresholds. Or vote on one 😆 For instance, the satiation threshold could be set as the mean or median number of approved candidates. In fact, choosing the median will automatically eliminate the possibility of majoritarian decoy sprinkling.

      However, now the satiation can "stagnate." If all voters are satiated, probably the whole satiation state needs to refresh somehow. Food for thought!

      posted in Voting Theoretic Criteria
      C
      cfrank
    • RE: Idea for truly proportional representation

      EDIT: I was reasonably skeptical at first, but I think I’m buying into the idea more, as long as certain safeguards are in place. Specifically, if the seating method is well-designed, and perhaps if supermajorities are required for certain decisions, then it seems as though it could be a very effective method. It’s a simple and interesting idea that looks promising, to me. Some pathologies do exist, including several recognized by the post's author, but I think I was able to address several of them with adjustments to the seating process and some additional rules. @Toby-Pereira I wonder what you think about this, since you have deeper knowledge of PR systems.

      My initial critique is as follows: @poppeacock I feel as though aspects are unclear. The manner in which the top candidates are selected, i.e. what is meant by the “seating tally” is not fully specified. This is recognized by the post's author.

      Furthermore, the method of power allocation can cause peculiar effects that are essentially majoritarian. As a simple example, if somehow there is a unanimously top-ranked candidate, then all power will be given solely to that top-ranked candidate, and the other seats will be completely powerless. This itself is a strange possibility, and I feel as though there are worse pathologies that may emerge, but I haven’t given it more than cursory consideration just now. This is also recognized by the post's author.

      Just generally, for any readers, considering the full implications of a new voting system can be very complicated, especially for people not practiced in analyzing them. I've been trying to get better at it over the years, but I'm not an expert. It’s good to try new things and think about the implications, but I think it’s generally good to err on the skeptical side, except regarding well-established, deeply analyzed methods with proven properties.

      If the author can write a transparent computer program that takes in ballots of a specified format and then returns a result according to their methodology, they probably should. Looking at some toy examples, though, it does seem to yield some interesting/compelling results. The fact that some seats may be vacated of power may be just a peculiarity.

      posted in Voting Theoretic Criteria
      C
      cfrank
    • Bioethics of Informed Consent

      The notion of consent is of foundational concern in political philosophy and has come up many times in this forum over the years. I wanted to share this lecture from a bioethics perspective, as food for thought:

      Youtube Video

      posted in Ethics
      C
      cfrank
    • RE: How do we technically give consent to our governments

      @tec referenda are interesting as an example, I would say they are more efficient in a sense, but the cost of that can be coherency. For example, referenda in California have led to incoherent policies, because the public often wants to have its cake and eat it too: the public wants service X, but simultaneously doesn’t want to pay for it, so they vote for X but also vote against tax increases that would pay for X. This effectively forces the government to borrow to reconcile public demands, which leads to debt that the public also doesn’t want.

      The government then gets criticized for borrowing, but in a sense, that is misplaced responsibility—the direct translation of an incoherent set of policies is the source of the issue, and borrowing is a symptom. This shows that representatives also serve the role of taking on coherent responsibility for coherent policy decisions, but citizens’ policy referenda can undermine that role in the kind of situation I described. Probably, the effects of this kind are less severe or even negligible in smaller, more internally cohesive populations like in Switzerland.

      Feedback is absolutely necessary, and structural issues as you indicate are major obstacles. If SAVE is a policy proposal generator, it seems to serve the role of a structured public forum. Is that accurate in your view? It seems like a more democratized form of a special interest group. How would the interests become translated into policy?

      posted in Political Theory
      C
      cfrank
    • RE: Fixing Participation Failure in “Approval vs B2R”

      I made a bit of conceptual progress with a potential proof (or route to a counterexample?) of participation for approval vs. B2R.

      The setup is as follows: E is an electorate, C is a candidate set, and v is some single new voter that when combined with E forms E'=EU{v}.
      The electoral processes of interest are then E(C) and E'(C), where we hope that participation is satisfied in the sense that if the winner of E(C) is W, and the winner of E'(C) is W', then v does not strictly prefer W to W'.

      We can consider the sequence of B2R losers L1, L2, ... Lk, and the corresponding L1', L2', ... Lk'.
      Then since under B2R the first k losers can never include the top-sorted candidate who is the adversary of the B2R survivor, it follows that the participation property will propagate by an inductive hypothesis if at any point (as in for some k), the sets {L1, L2, .. Lk} and {L1', L2', ... Lk'} coincide.
      It could also be possibly useful to know that B2R is equivalent to BNR. Furthermore, the methodology is only really of interest when there are more than two candidates.

      In any case, I think this method makes sure that the winner is either a highly approved candidate, or a candidate that a majority prefers over a highly approved candidate, which to me is an interesting guarantee. I still have not been able to find an example of participation failure... I have found instances though where the Condorcet loser is elected. Still, the Condorcet loser criterion seems only possible to fail by small chance when small electorates vote over very few candidates.

      posted in Single-winner
      C
      cfrank
    • RE: How do we technically give consent to our governments

      @tec I agree, most informed, pro-democracy people demand structural change to improve faithfulness of policy as well as more civic engagement. Direct policy-focused voting is ideal in principle, but on a large scale, it could be very inefficient. In my conception, the purpose of representatives is essentially to specialize in the aggregation and fusion of policy information and then interface with policy decisions. Unfortunately, removing that layer of abstraction might lead to chaos in various ways.

      I think your question/title of this post gets to the practical heart of what voting theory is about. Since we're concerned with consent here, what do you think the "ingredients" of consent might be? For example, I roughly imagine that to give consent, an individual needs adequate information about a proposal, sufficient resources to process that information about it, and mitigated or minimized "unnecessary" conflicts of interest. Those are all normative constructs, but the idea is that maybe we can decompose a complex construct like consent into simpler pieces, and then examine how those pieces might or might not hang together in the right way.

      More thought can make the construct of consent more complicated and multidimensional, It’s definitely something I want to read more about. I think core “defeaters” of consent would be sufficient severity of avoidable conflict between interests, plus epistemic aspects, and maybe others not considered.

      To me, some of the main issues with our current system is that we lack various aspects of that triangle. Individually, we don't have enough information, we hardly have sufficient resources to process what information we do have, and conflicts of interest are baked right into our institutions. Including the vote-for-one system, where the conflicts of interest are obvious, it's essentially extortion. In my view, representatives should function to address the first two points about information processing. What are your thoughts?

      Also no worries about prior engagements with conference and delay, I'll be frank in that I also haven't been able to give your proposal more than cursory consideration because of my own business, but as we and possibly others discuss, I'm sure we'll be able to prepare more food for thought. On the surface, it seems like your proposal does address the ingredients of consent I outlined, but efficiency and practical adoption may be significant issues. Not insurmountable though, and you may have already considered as much.

      posted in Political Theory
      C
      cfrank
    • RE: How do we technically give consent to our governments

      @tec I think it sounds like it would yield good results. I think we might need to have a more step-by-step dialogue about this to get a real understanding of what you’re proposing.

      One thought that comes to mind is that while multiple rounds of voting is simple on its face, it’s also a radical adjustment to the approach we are currently entrenched in. For that to fly, it would require significant efforts to educate and familiarize the public with the concept. Generally speaking, the simpler a system is, the more likely it is to be adopted.

      So my point is that I do like the principle, but personally I see it as something that could only realistically exist after a more foundational adjustment is made for it to develop on top of. Does that make sense?

      For example, it seems to require adoption a priori of an approval voting paradigm. That in itself is a significant hurdle.

      posted in Political Theory
      C
      cfrank
    • Integration with Existing Infrastructure

      I was discussing voting systems with a friend, and he was curious about how alternative voting systems would integrate into existing infrastructure such as districting and the electoral college.

      This seems like it could be a ground-up, potentially idiosyncratic thing, but we have seen adoptions in certain states of alternative systems and they have obviously integrated into a national level system. My curiosity is about the logistics of this on a larger scale, and if there is a clear roadmap that offers generality of scope for other states to follow suit.

      I’m wondering if people have more knowledge on this subject, and if they would be willing to share or collect resources here for others to investigate. I’ll probably look into this myself. I’m also opening a subject about historical examples of alternative systems, please chime in with any thoughts or considerations!

      posted in Election Policy and Reform
      C
      cfrank
    • RE: Kennedy Jr’s Candidacy as a Route to Voting Reform

      @toby-pereira apparently so, because they left. But honestly in terms of the purpose of a forum, that doesn’t really subtract from anything.

      Anyway, this original post was made well before RFK Jr.’s (imo reluctant) alignment with Trump. At least one of RFK Jr.’s predictions was correct, namely that Biden and/or Harris would not beat Trump. His “no spoiler” pledge would have given beating Trump the greatest possible chance, but Democrats refused to cooperate because they are power hungry, greedy, and benefit too much from the duopoly to concede to a third party candidate, even at the cost of Trump winning.

      IMO, that’s primarily why RFK Jr. angled against them, in game theory terms it was as a punishment. It was a textbook failed prisoner’s dilemma, and they got a taste of their own medicine in a way that hurt everybody and could have been avoided. But I digress.

      posted in Advocacy
      C
      cfrank
    • RE: Kennedy Jr’s Candidacy as a Route to Voting Reform

      @Isocratia I mean, maybe. But if you bail from a conversation just because people are discussing ideas that don’t neatly align with your views, I think that kind of runs counter to productive discussion. Engagement is the whole point of a forum. Why not take the opportunity to make your case? On that point, I don’t think I was being dogmatic, I was just putting a moderate, measured perspective out here. In particular, that if a candidate has comparable support to what Nader did, he should also be on the debate stage.

      As for Kennedy, I’m not sure if you followed his campaign directly, but from what I saw, his platform had some surprisingly rational moments. Whatever mistaken views he holds about healthcare, his core message was about dismantling corporate capture of government—which, let’s be honest, is exactly the route that’s brought us to the brink of fascism today. Frankly, he seemed more committed to stopping Trump than the Democrats did.

      Like him or not, he was a third-party candidate who genuinely threatened to shake up the duopoly—something we haven’t really seen since Nader. And given how deeply dysfunctional the two-party system has become, that’s not nothing. The political landscape is a real-time disaster, and reform doesn’t just happen on its own. While it wasn’t his main agenda, one thing I appreciated about his run is that he was literally the only candidate to talk about ranked-choice voting and other technical fixes.

      That said, I completely checked out when he aligned himself with Trump. At that point, his platform basically collapsed. His current sellout stance disillusioned a lot of his supporters—and honestly, he should’ve just bowed out once it was clear he couldn’t win.

      If you see it differently, I’d be interested to hear why. That’s why I brought this topic up in the first place.

      posted in Advocacy
      C
      cfrank
    • RE: Fixing Participation Failure in “Approval vs B2R”

      @toby-pereira yes definitely. I started trying to actually prove participation last evening, and it got much hairier than I would have liked... lots of branching edge-case conditions. I think an actual proof (or counterexample) of participation for this system would require some nice insights, and/or a larger scale planning and brute-force organized accounting of every relevant case.

      For example, I’m quite certain the new participant V can never change the top sorted candidate to somebody they prefer less. So it would have to be an upset via the B2R survivor, who would have to become the new winner, and be preferred less than the old winner by V. But that situation gets complicated in terms of the sorting and the rank tie-breaking authority… Maybe some day!

      posted in Single-winner
      C
      cfrank
    • RE: Fixing Participation Failure in “Approval vs B2R”

      @toby-pereira yes it’s a bit particular, that’s the part that’s designed to preserve participation. The +1 advantage plus tie break conferred to the adversary is essentially to prevent any single vote from changing the outcome of the participation criterion-satisfying method. It still needs proof or more auditing and adjustment. But it was motivated empirically by finding examples of participation failure without introducing the advantage and some other aspects.

      I think voters could have an anonymous ID given to them upon voting, it would have to be done with encryption. You’re right that in this case we would have to preclude latecomers, which I think would be fine. I think it could be done securely without an extra trip. This whole situation really makes “recounts” potential difficult though.

      Having the “sincere” rank be attached to the original ballot might also be an option, but voters would somehow need to know that the second ballot would not be used in the first election, for instance. The only way they can know for sure is if they don’t provide it until after the first election winners are revealed. That could also be done with encryption.

      In terms of preserving participation, the final runoff may not even be necessary. I’m trying to combine two things that can be looked at separately.

      Also thanks for reading and your thoughts! I’m starting to wonder about how to guarantee the Condorcet loser criterion while still preserving participation. As of now though I think the method is essentially approval but with significantly stronger Condorcet-like guarantees.

      EDIT: I just learned that there is an impossibility theorem about participation, independence of clones, and Condorcet loser. My guess is that the context and proof are similar to Arrow’s theorem, but the details I don’t know.

      posted in Single-winner
      C
      cfrank
    • Fixing Participation Failure in “Approval vs B2R”

      DISCLAIMER: This is conjectural and needs adjustments, but at least participation compliance can be improved. I have had LLMs run thousands of examples of this iteration, and have found no examples of participation failure. Still, it needs to be audited closely.

      To understand this method, you should also know about Bottom Two Runoff (B2R), which you can learn about here for example:

      https://www.votingtheory.org/forum/topic/564/bottom-n-and-bottom-2-runoffs-are-equivalent

      The method is a development of this concept:

      https://www.votingtheory.org/forum/topic/563/direct-independent-condorcet-validation/20

      For those perhaps not familiar with some voting theory, there are often desirable criteria of a voting system that are, unfortunately, mathematically impossible to reconcile with each other. An important example of this is the contention between the Condorcet criterion and the participation criterion. It turns out that satisfying the Condorcet criterion in every case guarantees some instances where participation fails, and vice versa.

      Consider the following method, which I’m just calling Approval vs. B2R, similar to Approval-seeded Llull as per @Jack-Waugh ---it's a bit technical, but there's a reason for that, so bear with me:

      DEFINITION

      (1) Voters submit rank ballots with approval cutoffs.
      (2) Candidates are sorted by approval rates, with rank-based head-to-head breaking ties if possible—by this, I mean that within a tied score group, we recursively pull Condorcet winners and losers to the top and bottom of the ranking until none remain, and then defer to an authoritative and consistent rank-order over the candidates to break Condorcet cycles and ties in the final sorting.
      (3) According to this sorting order, run B2R and identify the B2R survivor, with head-to-head ties broken by the sorting order.
      (4) Consider the top-sorted candidate. If this candidate is the same as the B2R survivor, elect them.
      (5) Otherwise, the top-sorted candidate will be an adversary to the B2R survivor. Run an independent head-to-head election between the B2R survivor and their adversary, with the following caveats:

      --> Voters are not tied down in any way to their original preference between the B2R survivor and the adversary, and can freely vote for either in the independent head-to-head. Also, barring logistical prohibitions, voters who did not participate in the first round should fully be allowed to participate in the final round. By default, voters' original ballots will be used to determine the preference between the B2R survivor and their adversary, but voters may opt in to swap their preference either 0 or 1 times, whichever is necessary for their final ballot to confer an advantage that they wish to disclose.
      --> However, based on these swaps, we can count the net number of swaps that are advantageous to the adversary over the B2R survivor compared with the original ballots. If this number is positive, the election proceeds as you would expect, with ties broken by the sort order. However, if the number is not positive, if the original head-to-head was in favor of the B2R survivor, and if a material difference would be incurred, then the adversary will be conferred an automatic +1 head-to-head advantage, and will also automatically win ties.

      I conjecture that these caveats about the runoff—including setting aside the B2R survivor, increasing the adversary’s advantage by +1, and giving them ties—together restore the participation criterion under fully sincere ballots, at the expense of the full Condorcet criterion. However, when the margins are not close, the Condorcet criterion is still satisfied if ballots are sincere.

      Here’s what else is fascinating about this: if participation does hold, then we can directly control the tradeoff between participation and Condorcet—in particular, when applicable, we can choose to increase the B2R adversary's margin over the B2R survivor by +1 with probability P. Then the method satisfies participation under sincere ballots with probability at least P, and simultaneously satisfies the Condorcet criterion under sincere ballots with probability at least 1-P.

      IN SUMMARY:

      This method I believe is participation compliant, which it is supposed to be by intentional design. This still needs to be proved. But as a consequence of this intention, it was also designed to fail Condorcet compliant in a controlled way. As per my comprehension, it will fail Condorcet compliance under these exact conditions:

      (1) The Condorcet winner C exists (and will therefore be the B2R survivor);
      (2) The approval winner Y is different from C;
      (3) The head-to-head rank-based margin of C over Y is either 0 or +1; and
      (4) The +1 boost to Y is applied, with ties going to Y.

      More generally, it will fail the Smith criterion under these exact conditions:

      (1) The approval winner Y is not in the Smith set;
      (2) The head-to-head rank-based margin of the B2R survivor over Y is either 0 or +1; and
      (3) The +1 boost to Y is applied, with ties going to Y.

      In all other cases, it satisfies the Smith criterion. Thus in a sense, this method tries to be as close to Smith compliant as possible while enforcing participation compliance as non-negotiable. It unconditionally satisfies a weakened version of the Condorcet criterion: If the Condorcet winner exists and its weakest margin of victory is at least 2, then the Condorcet winner is elected. It also unconditionally satisfies a more significantly weakened version of the Smith criterion: If every member of the Smith set has a weakest margin of victory against non-Smith set members of at least 2, then the election winner will belong to the Smith set.

      However, when the method fails the Smith criterion, it will necessarily fail the Condorcet loser criterion in the following circumstance:

      (1) The Condorcet loser is the only available adversary to the B2R survivor, which is only possible if the Condorcet loser alone attains the maximum approval rate.
      (2) The B2R survivor beats the Condorcet loser with a margin <=+1.

      While this is unlikely to occur in realistic elections, it is possible, and pathological examples can be generated. Addressing this is hard, because independence of clones, participation, and the Condorcet loser criterion are a “cursed triangle,” where any two are incompatible with the third. In our case, we satisfy independence of clones and participation, so examples of failing the Condorcet loser criterion inevitably must exist.

      Not that it's necessary to frame the properties in terms of Smith or Condorcet criterion-sounding conditions, but possibly those weak conditions can be strengthened. It is what it is.

      Future work will be to prove participation and to refine the mechanisms for guaranteeing participation.

      posted in Single-winner
      C
      cfrank
    • RE: Direct Independent Condorcet Validation

      @jack-waugh but that’s always the tradeoff with score systems, which is why people bullet vote and/or min-max (translate to approval). I totally understand what you’re saying though.

      I’m not saying the “Condorcet adversary” should be the score winner, just that they should be a strong alternative. Your approval-seeded Llull ballot could accommodate an approval winner as the Condorcet/Smith-method’s adversary, for example.

      I think a “rank with approval cutoff” ballot makes sense. Then there could be the approval winner, and, say, the B2R (Smith compliant) winner, followed by an independent head-to-head.

      posted in Single-winner
      C
      cfrank
    • RE: Direct Independent Condorcet Validation

      @jack-waugh I see to an extent, but I would argue that your collapse of rankings is incompatible with the distinction by score. You prefer one to the other, even if they are both horrible, right?

      posted in Single-winner
      C
      cfrank